diff --git a/.gitignore b/.gitignore
index cbc60aa1..7804c07b 100644
--- a/.gitignore
+++ b/.gitignore
@@ -165,6 +165,9 @@ configs/local/default.yaml
# Forks
/workdir/
/forks/alphafold3/*prediction_outputs/
+/forks/boltz/boltz/
+/forks/boltz/prediction_inputs/
+/forks/boltz/prediction_outputs/
/forks/chai-lab-orig/
/forks/chai-lab*/chai-lab/
/forks/chai-lab*/prediction_inputs/
@@ -199,3 +202,4 @@ configs/local/default.yaml
/forks/TULIP/outputs/
/forks/Vina/ADFR/
scripts/*inference*/
+scoring/
diff --git a/.pre-commit-config.yaml b/.pre-commit-config.yaml
index 45779def..9724400d 100644
--- a/.pre-commit-config.yaml
+++ b/.pre-commit-config.yaml
@@ -128,7 +128,7 @@ repos:
hooks:
- id: codespell
args:
- - --skip=logs/**,data/**,*.ipynb,posebench/utils/data_utils.py,posebench/utils/residue_utils.py,posebench/data/components/fasta_preparation.py,posebench/models/minimize_energy.py,posebench/data/components/create_casp15_ensemble_input_csv.py,posebench/analysis/casp15_ligand_scoring/casp_parser.py,*Components-smiles-stereo-oe.smi,notebooks/pdb_reports/transferase/*
+ - --skip=logs/**,data/**,notebooks/**,*.ipynb,posebench/utils/data_utils.py,posebench/utils/residue_utils.py,posebench/data/components/fasta_preparation.py,posebench/models/minimize_energy.py,posebench/data/components/create_casp15_ensemble_input_csv.py,posebench/analysis/casp15_ligand_scoring/casp_parser.py,*Components-smiles-stereo-oe.smi,notebooks/pdb_reports/transferase/*
# - --ignore-words-list=abc,def
# jupyter notebook cell output clearing
diff --git a/CHANGELOG.md b/CHANGELOG.md
index 34a98a2b..b7aba26d 100644
--- a/CHANGELOG.md
+++ b/CHANGELOG.md
@@ -1,3 +1,24 @@
+### 0.7.0 - 08/11/2025
+
+**Additions**:
+
+- Added new baseline methods (Boltz-1/2 w/ and w/o with multiple sequence alignments (MSAs)).
+- Added a new failure mode analysis notebook incorporating PLINDER for robust method generalization analysis(n.b., see new arXiv preprint for more details).
+- Added a script for performing custom method generalization analyses (e.g., when new methods are released which were trained on more recent splits of the PDB compared to AlphaFold 3's cutoff date of September 30, 2021).
+
+**Changes**:
+
+- Updated the `posebusters` package version to (at the time of writing) the latest version `0.4.5` to integrate new (stricter) pose checks (e.g., regarding flat aliphatic rings). Overall, each method's PoseBusters validity scores have decreased slightly on average (as expected).
+
+**Bug Fixes**:
+
+- Fixed a bug related to the number of DockGen-E protein chains provided to Chai-1 for inference on this dataset. Chai-1's DockGen-E results accordingly have been updated.
+
+**Results**:
+
+- With all the above changes in place, re-analyzed all baseline methods for each benchmark dataset, and updated the baseline predictions hosted on Zenodo
+- **NOTE**: The updated arXiv preprint should be publicly available by 08/15/2025
+
### 0.6.0 - 02/09/2025
**Additions**:
@@ -21,7 +42,7 @@
**Results**:
-- With all the above changed in place, simplified, re-ran, and re-analyzed all baseline methods for each benchmark dataset, and updated the baseline predictions and datasets (now containing standardized MSAs) hosted on Zenodo
+- With all the above changes in place, simplified, re-ran, and re-analyzed all baseline methods for each benchmark dataset, and updated the baseline predictions and datasets (now containing standardized MSAs) hosted on Zenodo
- **NOTE**: The updated arXiv preprint should be publicly available by 02/12/2025
### 0.5.0 - 09/30/2024
diff --git a/README.md b/README.md
index eccec5c4..3ab40da3 100644
--- a/README.md
+++ b/README.md
@@ -3,7 +3,7 @@
# PoseBench
[](https://arxiv.org/abs/2405.14108)
-[](https://doi.org/10.5281/zenodo.14629652)
+[](https://doi.org/10.5281/zenodo.16791095)
[](https://badge.fury.io/py/posebench)
[](https://www.repostatus.org/#active)
[](https://bioinfomachinelearning.github.io/PoseBench/)
@@ -113,6 +113,10 @@ cd forks/RoseTTAFold-All-Atom/rf2aa/SE3Transformer/ && pip3 install --no-cache-d
mamba env create -f environments/chai_lab_environment.yaml --prefix forks/chai-lab/chai-lab/
conda activate forks/chai-lab/chai-lab/ # NOTE: one still needs to use `conda` to (de)activate environments
pip3 install forks/chai-lab/
+# - Boltz environment (~5 GB)
+mamba env create -f environments/boltz_environment.yaml --prefix forks/boltz/boltz/
+conda activate forks/boltz/boltz/ # NOTE: one still needs to use `conda` to (de)activate environments
+cd forks/boltz/ && pip3 install -e .[cuda] && cd ../../
# - AutoDock Vina Tools environment (~1 GB)
mamba env create -f environments/adfr_environment.yaml --prefix forks/Vina/ADFR/
conda activate forks/Vina/ADFR/ # NOTE: one still needs to use `conda` to (de)activate environments
@@ -152,6 +156,37 @@ wget http://files.ipd.uw.edu/pub/RF-All-Atom/weights/RFAA_paper_weights.pt
cd ../../
```
+(Optional) Download PLINDER-based similarity metrics for method generalization analysis (~0.5 GB total)
+
+```bash
+mkdir -p ./data/plinder/
+wget -P ./data/plinder/ https://zenodo.org/records/16754298/files/annotations.csv
+wget -P ./data/plinder/ https://zenodo.org/records/16754298/files/all_similarity_scores.parquet
+```
+
+(Optional) Alternatively, download PLINDER to perform a method generalization analysis for custom (new) datasets (~500 GB total)
+
+```bash
+# download fixed version of PLINDER
+export PLINDER_RELEASE=2024-06
+export PLINDER_ITERATION=v2
+mkdir -p ./data/plinder/${PLINDER_RELEASE}/${PLINDER_ITERATION}/
+gsutil -m cp -r "gs://plinder/${PLINDER_RELEASE}/${PLINDER_ITERATION}/*" ./data/plinder/${PLINDER_RELEASE}/${PLINDER_ITERATION}/
+
+# unpack system files of fixed version of PLINDER
+cd ./data/plinder/${PLINDER_RELEASE}/${PLINDER_ITERATION}/systems; for i in `ls *zip`; do unzip $i; touch ${i//.zip/}_done; done
+cd ../../../../../
+
+# customize `similarity_scoring.py` to similarity-match a (bespoke) subset of new PDB complex IDs for (blind) benchmarking
+python3 posebench/analysis/similarity_scoring.py $PDB_ID_FROM_NEW_SUBSET # e.g., in a for-loop or in parallel
+
+# combine each score of the new subset into a singular (new) `all_similarity_scores.parquet` file
+python3 -c "import os, pandas as pd; from glob import glob; files = glob(os.path.join('scoring', 'scores', 'scores', 'all_scores', '*.parquet')); pd.concat([pd.read_parquet(f) for f in files], ignore_index=True).to_parquet('data', 'plinder', 'all_similarity_scores.parquet')"
+
+# update annotations
+python3 -c "import re; pdb_ids_pattern = '|'.join(map(re.escape, $PDB_IDS_IN_NEW_SUBSET)); similarity_df_custom = all_similarity_scores[~all_similarity_scores["target_system"].str.contains(pdb_ids_pattern, na=False)].sort_values(by='sucos_shape_pocket_qcov', ascending=False).groupby('group_key').head(1).reset_index(drop=True); similarity_custom = dict(zip(similarity_df_custom['group_key'], similarity_df_custom['sucos_shape_pocket_qcov'])); annotated_df['sucos_shape_pocket_qcov_custom'] = annotated_df['group_key'].map(similarity_custom); annotated_df.to_csv(os.path.join('data', 'plinder', 'annotations.csv'))"
+```
+
## Tutorials
@@ -174,10 +209,10 @@ of how to extend `PoseBench`, as outlined below.
```bash
# fetch, extract, and clean-up preprocessed Astex Diverse, PoseBusters Benchmark, DockGen, and CASP15 data (~3 GB) #
-wget https://zenodo.org/records/14629652/files/astex_diverse_set.tar.gz
-wget https://zenodo.org/records/14629652/files/posebusters_benchmark_set.tar.gz
-wget https://zenodo.org/records/14629652/files/dockgen_set.tar.gz
-wget https://zenodo.org/records/14629652/files/casp15_set.tar.gz
+wget https://zenodo.org/records/16791095/files/astex_diverse_set.tar.gz
+wget https://zenodo.org/records/16791095/files/posebusters_benchmark_set.tar.gz
+wget https://zenodo.org/records/16791095/files/dockgen_set.tar.gz
+wget https://zenodo.org/records/16791095/files/casp15_set.tar.gz
tar -xzf astex_diverse_set.tar.gz
tar -xzf posebusters_benchmark_set.tar.gz
tar -xzf dockgen_set.tar.gz
@@ -193,35 +228,39 @@ rm casp15_set.tar.gz
```bash
# fetch, extract, and clean-up benchmark method predictions to reproduce paper results (~19 GB) #
# AutoDock Vina predictions and results
-wget https://zenodo.org/records/14629652/files/vina_benchmark_method_predictions.tar.gz
+wget https://zenodo.org/records/16791095/files/vina_benchmark_method_predictions.tar.gz
tar -xzf vina_benchmark_method_predictions.tar.gz
rm vina_benchmark_method_predictions.tar.gz
# DiffDock predictions and results
-wget https://zenodo.org/records/14629652/files/diffdock_benchmark_method_predictions.tar.gz
+wget https://zenodo.org/records/16791095/files/diffdock_benchmark_method_predictions.tar.gz
tar -xzf diffdock_benchmark_method_predictions.tar.gz
rm diffdock_benchmark_method_predictions.tar.gz
# DynamicBind predictions and results
-wget https://zenodo.org/records/14629652/files/dynamicbind_benchmark_method_predictions.tar.gz
+wget https://zenodo.org/records/16791095/files/dynamicbind_benchmark_method_predictions.tar.gz
tar -xzf dynamicbind_benchmark_method_predictions.tar.gz
rm dynamicbind_benchmark_method_predictions.tar.gz
# NeuralPLexer predictions and results
-wget https://zenodo.org/records/14629652/files/neuralplexer_benchmark_method_predictions.tar.gz
+wget https://zenodo.org/records/16791095/files/neuralplexer_benchmark_method_predictions.tar.gz
tar -xzf neuralplexer_benchmark_method_predictions.tar.gz
rm neuralplexer_benchmark_method_predictions.tar.gz
# RoseTTAFold-All-Atom predictions and results
-wget https://zenodo.org/records/14629652/files/rfaa_benchmark_method_predictions.tar.gz
+wget https://zenodo.org/records/16791095/files/rfaa_benchmark_method_predictions.tar.gz
tar -xzf rfaa_benchmark_method_predictions.tar.gz
rm rfaa_benchmark_method_predictions.tar.gz
# Chai-1 predictions and results
-wget https://zenodo.org/records/14629652/files/chai_benchmark_method_predictions.tar.gz
+wget https://zenodo.org/records/16791095/files/chai_benchmark_method_predictions.tar.gz
tar -xzf chai_benchmark_method_predictions.tar.gz
rm chai_benchmark_method_predictions.tar.gz
+# Boltz-1 predictions and results
+wget https://zenodo.org/records/16791095/files/boltz_benchmark_method_predictions.tar.gz
+tar -xzf boltz_benchmark_method_predictions.tar.gz
+rm boltz_benchmark_method_predictions.tar.gz
# AlphaFold 3 predictions and results
-wget https://zenodo.org/records/14629652/files/af3_benchmark_method_predictions.tar.gz
+wget https://zenodo.org/records/16791095/files/af3_benchmark_method_predictions.tar.gz
tar -xzf af3_benchmark_method_predictions.tar.gz
rm af3_benchmark_method_predictions.tar.gz
# CASP15 predictions and results for all methods
-wget https://zenodo.org/records/14629652/files/casp15_benchmark_method_predictions.tar.gz
+wget https://zenodo.org/records/16791095/files/casp15_benchmark_method_predictions.tar.gz
tar -xzf casp15_benchmark_method_predictions.tar.gz
rm casp15_benchmark_method_predictions.tar.gz
```
@@ -231,7 +270,7 @@ rm casp15_benchmark_method_predictions.tar.gz
```bash
# fetch, extract, and clean-up benchmark method interactions to reproduce paper results (~12 GB) #
# cached ProLIF interactions for notebook plots
-wget https://zenodo.org/records/14629652/files/posebench_notebooks.tar.gz
+wget https://zenodo.org/records/16791095/files/posebench_notebooks.tar.gz
tar -xzf posebench_notebooks.tar.gz
rm posebench_notebooks.tar.gz
```
@@ -318,7 +357,7 @@ python3 posebench/data/components/protein_apo_to_holo_alignment.py dataset=casp1
conda deactivate
```
-**NOTE:** The preprocessed Astex Diverse, PoseBusters Benchmark, DockGen, and CASP15 data available via [Zenodo](https://doi.org/10.5281/zenodo.14629652) provide pre-holo-aligned protein structures predicted by AlphaFold 3 (and alternatively MIT-licensed ESMFold) for these respective datasets. Accordingly, users must ensure their usage of such predicted protein structures from AlphaFold 3 aligns with AlphaFold 3's [Terms of Use](https://github.com/google-deepmind/alphafold3/blob/main/WEIGHTS_TERMS_OF_USE.md).
+**NOTE:** The preprocessed Astex Diverse, PoseBusters Benchmark, DockGen, and CASP15 data available via [Zenodo](https://doi.org/10.5281/zenodo.16791095) provide pre-holo-aligned protein structures predicted by AlphaFold 3 (and alternatively MIT-licensed ESMFold) for these respective datasets. Accordingly, users must ensure their usage of such predicted protein structures from AlphaFold 3 aligns with AlphaFold 3's [Terms of Use](https://github.com/google-deepmind/alphafold3/blob/main/WEIGHTS_TERMS_OF_USE.md).
@@ -339,14 +378,15 @@ conda deactivate
#### Flexible Protein Methods
-| Name | Source | Astex Benchmarked | PoseBusters Benchmarked | DockGen Benchmarked | CASP Benchmarked |
-| ---------------------- | ----------------------------------------------------------------------------- | ----------------- | ----------------------- | ------------------- | ---------------- |
-| `DynamicBind` | [Lu et al.](https://www.nature.com/articles/s41467-024-45461-2) | ✓ | ✓ | ✓ | ✓ |
-| `NeuralPLexer` | [Qiao et al.](https://www.nature.com/articles/s42256-024-00792-z) | ✓ | ✓ | ✓ | ✓ |
-| `FlowDock` | [Morehead et al.](https://arxiv.org/abs/2412.10966) | ✓ | ✓ | ✓ | ✓ |
-| `RoseTTAFold-All-Atom` | [Krishna et al.](https://www.science.org/doi/10.1126/science.adl2528) | ✓ | ✓ | ✓ | ✓ |
-| `Chai-1` | [Chai Discovery](https://chaiassets.com/chai-1/paper/technical_report_v1.pdf) | ✓ | ✓ | ✓ | ✓ |
-| `AlphaFold 3` | [Abramson et al.](https://www.nature.com/articles/s41586-024-07487-w) | ✓ | ✓ | ✓ | ✓ |
+| Name | Source | Astex Benchmarked | PoseBusters Benchmarked | DockGen Benchmarked | CASP Benchmarked |
+| ---------------------- | ------------------------------------------------------------------------------ | ----------------- | ----------------------- | ------------------- | ---------------- |
+| `DynamicBind` | [Lu et al.](https://www.nature.com/articles/s41467-024-45461-2) | ✓ | ✓ | ✓ | ✓ |
+| `NeuralPLexer` | [Qiao et al.](https://www.nature.com/articles/s42256-024-00792-z) | ✓ | ✓ | ✓ | ✓ |
+| `FlowDock` | [Morehead et al.](https://arxiv.org/abs/2412.10966) | ✓ | ✓ | ✓ | ✓ |
+| `RoseTTAFold-All-Atom` | [Krishna et al.](https://www.science.org/doi/10.1126/science.adl2528) | ✓ | ✓ | ✓ | ✓ |
+| `Chai-1` | [Chai Discovery](https://chaiassets.com/chai-1/paper/technical_report_v1.pdf) | ✓ | ✓ | ✓ | ✓ |
+| `Boltz` | [Wohlwend et al.](https://www.biorxiv.org/content/10.1101/2024.11.19.624167v4) | ✓ | ✓ | ✓ | ✓ |
+| `AlphaFold 3` | [Abramson et al.](https://www.nature.com/articles/s41586-024-07487-w) | ✓ | ✓ | ✓ | ✓ |
### Methods available for ensembling
@@ -360,14 +400,15 @@ conda deactivate
#### Flexible Protein Methods
-| Name | Source | Astex Benchmarked | PoseBusters Benchmarked | DockGen Benchmarked | CASP Benchmarked |
-| ---------------------- | ----------------------------------------------------------------------------- | ----------------- | ----------------------- | ------------------- | ---------------- |
-| `DynamicBind` | [Lu et al.](https://www.nature.com/articles/s41467-024-45461-2) | ✓ | ✓ | ✓ | ✓ |
-| `NeuralPLexer` | [Qiao et al.](https://www.nature.com/articles/s42256-024-00792-z) | ✓ | ✓ | ✓ | ✓ |
-| `FlowDock` | [Morehead et al.](https://arxiv.org/abs/2412.10966) | ✓ | ✓ | ✓ | ✓ |
-| `RoseTTAFold-All-Atom` | [Krishna et al.](https://www.science.org/doi/10.1126/science.adl2528) | ✓ | ✓ | ✓ | ✓ |
-| `Chai-1` | [Chai Discovery](https://chaiassets.com/chai-1/paper/technical_report_v1.pdf) | ✓ | ✓ | ✓ | ✓ |
-| `AlphaFold 3` | [Abramson et al.](https://www.nature.com/articles/s41586-024-07487-w) | ✓ | ✓ | ✓ | ✓ |
+| Name | Source | Astex Benchmarked | PoseBusters Benchmarked | DockGen Benchmarked | CASP Benchmarked |
+| ---------------------- | ------------------------------------------------------------------------------ | ----------------- | ----------------------- | ------------------- | ---------------- |
+| `DynamicBind` | [Lu et al.](https://www.nature.com/articles/s41467-024-45461-2) | ✓ | ✓ | ✓ | ✓ |
+| `NeuralPLexer` | [Qiao et al.](https://www.nature.com/articles/s42256-024-00792-z) | ✓ | ✓ | ✓ | ✓ |
+| `FlowDock` | [Morehead et al.](https://arxiv.org/abs/2412.10966) | ✓ | ✓ | ✓ | ✓ |
+| `RoseTTAFold-All-Atom` | [Krishna et al.](https://www.science.org/doi/10.1126/science.adl2528) | ✓ | ✓ | ✓ | ✓ |
+| `Chai-1` | [Chai Discovery](https://chaiassets.com/chai-1/paper/technical_report_v1.pdf) | ✓ | ✓ | ✓ | ✓ |
+| `Boltz` | [Wohlwend et al.](https://www.biorxiv.org/content/10.1101/2024.11.19.624167v4) | ✓ | ✓ | ✓ | ✓ |
+| `AlphaFold 3` | [Abramson et al.](https://www.nature.com/articles/s41586-024-07487-w) | ✓ | ✓ | ✓ | ✓ |
**NOTE**: Have a new method to add? Please let us know by creating a pull request. We would be happy to work with you to integrate new methodology into this benchmark!
@@ -859,6 +900,93 @@ python3 posebench/analysis/inference_analysis_casp.py method=chai-lab dataset=ca
...
```
+### How to run inference with `Boltz`
+
+Prepare CSV input files
+
+```bash
+python3 posebench/data/boltz_input_preparation.py dataset=posebusters_benchmark
+python3 posebench/data/boltz_input_preparation.py dataset=astex_diverse
+python3 posebench/data/boltz_input_preparation.py dataset=dockgen
+python3 posebench/data/boltz_input_preparation.py dataset=casp15 input_data_dir=data/casp15_set/targets
+```
+
+Run inference on each dataset
+
+```bash
+conda activate forks/boltz/boltz/
+python3 posebench/models/boltz_inference.py dataset=posebusters_benchmark repeat_index=1
+...
+python3 posebench/models/boltz_inference.py dataset=astex_diverse repeat_index=1
+...
+python3 posebench/models/boltz_inference.py dataset=dockgen repeat_index=1
+...
+python3 posebench/models/boltz_inference.py dataset=casp15 repeat_index=1
+...
+conda deactivate
+```
+
+Extract predictions into separate files for proteins and ligands
+
+```bash
+python3 posebench/data/boltz_output_extraction.py dataset=posebusters_benchmark repeat_index=1
+...
+python3 posebench/data/boltz_output_extraction.py dataset=astex_diverse repeat_index=1
+...
+python3 posebench/data/boltz_output_extraction.py dataset=dockgen repeat_index=1
+...
+python3 posebench/data/boltz_output_extraction.py dataset=casp15 repeat_index=1
+...
+```
+
+Relax the generated ligand structures inside of their respective protein pockets
+
+```bash
+python3 posebench/models/inference_relaxation.py method=boltz dataset=posebusters_benchmark remove_initial_protein_hydrogens=true repeat_index=1
+...
+python3 posebench/models/inference_relaxation.py method=boltz dataset=astex_diverse remove_initial_protein_hydrogens=true repeat_index=1
+...
+python3 posebench/models/inference_relaxation.py method=boltz dataset=dockgen remove_initial_protein_hydrogens=true repeat_index=1
+...
+```
+
+Align predicted protein-ligand structures to ground-truth complex structures
+
+```bash
+conda activate PyMOL-PoseBench
+python3 posebench/analysis/complex_alignment.py method=boltz dataset=posebusters_benchmark repeat_index=1
+...
+python3 posebench/analysis/complex_alignment.py method=boltz dataset=astex_diverse repeat_index=1
+...
+python3 posebench/analysis/complex_alignment.py method=boltz dataset=dockgen repeat_index=1
+conda deactivate
+...
+```
+
+Analyze inference results for each dataset
+
+```bash
+python3 posebench/analysis/inference_analysis.py method=boltz dataset=posebusters_benchmark repeat_index=1
+...
+python3 posebench/analysis/inference_analysis.py method=boltz dataset=astex_diverse repeat_index=1
+...
+python3 posebench/analysis/inference_analysis.py method=boltz dataset=dockgen repeat_index=1
+...
+```
+
+Analyze inference results for the CASP15 dataset
+
+```bash
+# first assemble (unrelaxed and post ranking-relaxed) CASP15-compliant prediction submission files for scoring
+python3 posebench/models/ensemble_generation.py ensemble_methods=\[boltz\] input_csv_filepath=data/test_cases/casp15/ensemble_inputs.csv output_dir=data/test_cases/casp15/top_boltz_ensemble_predictions_1 skip_existing=true relax_method_ligands_post_ranking=false export_file_format=casp15 export_top_n=5 combine_casp_output_files=true max_method_predictions=5 method_top_n_to_select=5 resume=true ensemble_benchmarking=true ensemble_benchmarking_dataset=casp15 cuda_device_index=0 ensemble_benchmarking_repeat_index=1
+python3 posebench/models/ensemble_generation.py ensemble_methods=\[boltz\] input_csv_filepath=data/test_cases/casp15/ensemble_inputs.csv output_dir=data/test_cases/casp15/top_boltz_ensemble_predictions_1 skip_existing=true relax_method_ligands_post_ranking=true export_file_format=casp15 export_top_n=5 combine_casp_output_files=true max_method_predictions=5 method_top_n_to_select=5 resume=true ensemble_benchmarking=true ensemble_benchmarking_dataset=casp15 cuda_device_index=0 ensemble_benchmarking_repeat_index=1
+# NOTE: the suffixes for both `output_dir` and `ensemble_benchmarking_repeat_index` should be modified to e.g., 2, 3, ...
+...
+# now score the CASP15-compliant submissions using the official CASP scoring pipeline
+python3 posebench/analysis/inference_analysis_casp.py method=boltz dataset=casp15 repeat_index=1
+...
+```
+
### How to run inference with `AlphaFold 3`
Run inference (3x) using the academically-available inference code released on [GitHub](https://github.com/google-deepmind/alphafold3), saving each run's structures to a unique output directory located at `forks/alphafold3/prediction_outputs/{dataset=posebusters_benchmark,astex_diverse,dockgen,casp15}_{repeat_index=1,2,3}`
@@ -1130,6 +1258,8 @@ jupyter notebook notebooks/casp15_inference_results_plotting.ipynb
Inspect the failure modes of each method
```bash
+jupyter notebook notebooks/failure_modes_analysis_plotting_plinder.ipynb
+# or
jupyter notebook notebooks/failure_modes_analysis_plotting.ipynb
```
@@ -1181,6 +1311,7 @@ rm -rf docs/build/ && sphinx-build docs/source/ docs/build/ # NOTE: errors can s
- [AutoDock-Vina](https://github.com/ccsb-scripps/AutoDock-Vina)
- [alphafold3](https://github.com/google-deepmind/alphafold3)
+- [boltz](https://github.com/jwohlwend/boltz)
- [casp15_ligand](https://git.scicore.unibas.ch/schwede/casp15_ligand)
- [chai-lab](https://github.com/chaidiscovery/chai-lab)
- [DiffDock](https://github.com/gcorso/DiffDock)
@@ -1189,10 +1320,12 @@ rm -rf docs/build/ && sphinx-build docs/source/ docs/build/ # NOTE: errors can s
- [FlowDock](https://github.com/BioinfoMachineLearning/FlowDock)
- [lightning-hydra-template](https://github.com/ashleve/lightning-hydra-template)
- [NeuralPLexer](https://github.com/zrqiao/NeuralPLexer)
+- [plinder](https://github.com/plinder-org/plinder)
- [ProteinWorkshop](https://github.com/a-r-j/ProteinWorkshop)
- [posebusters](https://github.com/maabuu/posebusters)
- [posebusters_em](https://github.com/maabuu/posebusters_em)
- [RoseTTAFold-All-Atom](https://github.com/baker-laboratory/RoseTTAFold-All-Atom)
+- [runs-n-poses](https://github.com/plinder-org/runs-n-poses)
- [tulip](https://github.com/BioinfoMachineLearning/tulip)
We thank all their contributors and maintainers!
diff --git a/configs/analysis/complex_alignment.yaml b/configs/analysis/complex_alignment.yaml
index 657e7776..55240ced 100644
--- a/configs/analysis/complex_alignment.yaml
+++ b/configs/analysis/complex_alignment.yaml
@@ -1,5 +1,5 @@
-method: neuralplexer # the method for which to align predictions - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `alphafold3`)
-vina_binding_site_method: p2rank # the method to use for Vina binding site prediction - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `alphafold3`, `p2rank`)
+method: neuralplexer # the method for which to align predictions - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `boltz`, `alphafold3`)
+vina_binding_site_method: p2rank # the method to use for Vina binding site prediction - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `boltz`, `alphafold3`, `p2rank`)
dataset: posebusters_benchmark # the dataset to use - NOTE: must be one of (`posebusters_benchmark`, `astex_diverse`, `dockgen`, `casp15`)
ensemble_ranking_method: consensus # the method with which to rank-order and select the top ensemble prediction for each target - NOTE: must be one of (`consensus`, `ff`)
input_data_dir: ${oc.env:PROJECT_ROOT}/data/${dataset}_set # the input protein-ligand complex directory to recursively parse
diff --git a/configs/analysis/inference_analysis.yaml b/configs/analysis/inference_analysis.yaml
index 3e21251d..0e9c3d86 100644
--- a/configs/analysis/inference_analysis.yaml
+++ b/configs/analysis/inference_analysis.yaml
@@ -1,6 +1,6 @@
full_report: true # whether to generate a full PoseBusters report (i.e. with all metrics) or a summary report (i.e. with only the most important metrics)
-method: diffdock # the method for which to score predictions - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `alphafold3`, `vina`, `ensemble`)
-vina_binding_site_method: p2rank # the method to use for Vina binding site prediction - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `alphafold3`, `p2rank`)
+method: diffdock # the method for which to score predictions - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `boltz`, `alphafold3`, `vina`, `ensemble`)
+vina_binding_site_method: p2rank # the method to use for Vina binding site prediction - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `boltz`, `alphafold3`, `p2rank`)
dataset: posebusters_benchmark # the dataset to use - NOTE: must be one of (`posebusters_benchmark`, `astex_diverse`, `dockgen`, `casp15`)
ensemble_ranking_method: consensus # the method with which to rank-order and select the top ensemble prediction for each target - NOTE: must be one of (`consensus`, `ff`)
input_csv_path: ${resolve_method_input_csv_path:${method},${dataset},${pocket_only_baseline}} # the input CSV filepath with which to run inference
diff --git a/configs/analysis/inference_analysis_casp.yaml b/configs/analysis/inference_analysis_casp.yaml
index da1520d1..aa1bfc1a 100644
--- a/configs/analysis/inference_analysis_casp.yaml
+++ b/configs/analysis/inference_analysis_casp.yaml
@@ -1,8 +1,8 @@
full_report: true # whether to generate a full PoseBusters report (i.e. with all metrics) or a summary report (i.e. with only the most important metrics)
python_exec_path: ${oc.env:HOME}/mambaforge/envs/casp15_ligand_scoring/bin/python3 # the Python executable to use
scoring_script_path: ${oc.env:PROJECT_ROOT}/posebench/analysis/casp15_ligand_scoring/score_predictions.py # the path to the script to use for scoring CASP predictions
-method: diffdock # the method for which to score predictions - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `alphafold3`, `vina`, `ensemble`, `tulip`)
-vina_binding_site_method: p2rank # the method to use for Vina binding site prediction - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `alphafold3`, `p2rank`)
+method: diffdock # the method for which to score predictions - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `boltz`, `alphafold3`, `vina`, `ensemble`, `tulip`)
+vina_binding_site_method: p2rank # the method to use for Vina binding site prediction - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `boltz`, `alphafold3`, `p2rank`)
dataset: casp15 # the dataset to use - NOTE: must be one of (`casp15`)
ensemble_ranking_method: consensus # the method with which to rank-order and select the top ensemble prediction for each target - NOTE: must be one of (`consensus`, `ff`)
predictions_dir: ${oc.env:PROJECT_ROOT}/data/test_cases/${dataset}/top_${method}_ensemble_predictions_${repeat_index} # the directory containing the predictions to analyze
@@ -15,4 +15,5 @@ no_ilcl: false # whether to score a model trained without an inter-ligand clash
relax_protein: false # whether to relax the protein - NOTE: currently periodically yields unpredictable protein-ligand separation
v1_baseline: false # whether to score the v1 baseline predictions
allow_missing_predictions: true # whether to allow missing predictions for a target
-force_rescore: false # whether to force CASP15 and PoseBusters rescoring of the predictions
+force_casp15_rescore: false # whether to force CASP15 rescoring of the predictions
+force_pb_rescore: false # whether to force PoseBusters rescoring of the predictions
diff --git a/configs/data/boltz_input_preparation.yaml b/configs/data/boltz_input_preparation.yaml
new file mode 100644
index 00000000..aa791960
--- /dev/null
+++ b/configs/data/boltz_input_preparation.yaml
@@ -0,0 +1,10 @@
+dataset: posebusters_benchmark # the dataset to use - NOTE: must be one of (`posebusters_benchmark`, `astex_diverse`, `dockgen`, `casp15`)
+input_data_dir: ${oc.env:PROJECT_ROOT}/data/${dataset}_set # the input protein-ligand complex directory to recursively parse
+msa_dir: ${oc.env:PROJECT_ROOT}/data/${dataset}_set/${dataset}_boltz_msas # the directory containing the `.csv` MSA files prepared for Boltz via `posebench/data/components/prepare_boltz_msas.py`; if not provided, Boltz will be run in single-sequence mode
+output_scripts_path: ${oc.env:PROJECT_ROOT}/forks/boltz/prediction_inputs/${dataset} # the output directory in which to save the input files
+posebusters_ccd_ids_filepath: ${oc.env:PROJECT_ROOT}/data/posebusters_pdb_ccd_ids.txt # the path to the PoseBusters PDB CCD IDs file that lists the targets that do not contain any crystal contacts
+dockgen_test_ids_filepath: ${oc.env:PROJECT_ROOT}/data/dockgen_set/split_test.txt # the path to the DockGen test set IDs file
+protein_filepath: null # the path to the protein structure file to use
+ligand_smiles: null # the ligand SMILES string for which to predict the binding pose
+input_id: null # the input ID to use for inference
+pocket_only_baseline: false # whether to prepare the pocket-only baseline
diff --git a/configs/data/boltz_output_extraction.yaml b/configs/data/boltz_output_extraction.yaml
new file mode 100644
index 00000000..aa8e02b6
--- /dev/null
+++ b/configs/data/boltz_output_extraction.yaml
@@ -0,0 +1,13 @@
+dataset: posebusters_benchmark # the dataset to use - NOTE: must be one of (`posebusters_benchmark`, `astex_diverse`, `dockgen`, `casp15`)
+prediction_inputs_dir: ${oc.env:PROJECT_ROOT}/forks/boltz/prediction_inputs/${dataset}
+prediction_outputs_dir: ${oc.env:PROJECT_ROOT}/forks/boltz/prediction_outputs/${dataset}_${repeat_index}
+inference_outputs_dir: ${oc.env:PROJECT_ROOT}/forks/boltz/inference/boltz_${dataset}_outputs_${repeat_index}
+input_data_dir: ${oc.env:PROJECT_ROOT}/data/${dataset}_set # the input protein-ligand complex directory to recursively parse
+posebusters_ccd_ids_filepath: ${oc.env:PROJECT_ROOT}/data/posebusters_pdb_ccd_ids.txt # the path to the PoseBusters PDB CCD IDs file that lists the targets that do not contain any crystal contacts
+dockgen_test_ids_filepath: ${oc.env:PROJECT_ROOT}/data/dockgen_set/split_test.txt # the path to the DockGen test set IDs file
+complex_filepath: null # if not `null`, this should be the path to the complex PDB file for which to extract outputs
+complex_id: null # if not `null`, this should be the complex ID of the single complex for which to extract outputs
+ligand_smiles: null # if not `null`, this should be the (i.e., `.` fragment-separated) complex ligand SMILES string of the single complex for which to extract outputs
+output_dir: null # if not `null`, this should be the path to the output file to which to write the extracted outputs
+repeat_index: 1 # the repeat index with which inference was run
+pocket_only_baseline: false # whether to prepare the pocket-only baseline
diff --git a/configs/data/components/prepare_boltz_msas.yaml b/configs/data/components/prepare_boltz_msas.yaml
new file mode 100644
index 00000000..01b74815
--- /dev/null
+++ b/configs/data/components/prepare_boltz_msas.yaml
@@ -0,0 +1,6 @@
+dataset: posebusters_benchmark # the dataset to use - NOTE: must be one of (`posebusters_benchmark`, `astex_diverse`, `dockgen`, `casp15`)
+input_data_dir: ${oc.env:PROJECT_ROOT}/data/${dataset}_set # the input protein-ligand complex directory to recursively parse
+input_msa_dir: ${oc.env:PROJECT_ROOT}/data/${dataset}_set/${dataset}_msas # where the original MSA files are placed
+output_msa_dir: ${oc.env:PROJECT_ROOT}/data/${dataset}_set/${dataset}_boltz_msas # where the processed MSA files should be stored
+skip_existing: true # whether to skip processing if the output file already exists
+pocket_only_baseline: false # whether to prepare the pocket-only baseline
diff --git a/configs/data/components/prepare_chai_msas.yaml b/configs/data/components/prepare_chai_msas.yaml
index 6ad9aaee..96b34e9c 100644
--- a/configs/data/components/prepare_chai_msas.yaml
+++ b/configs/data/components/prepare_chai_msas.yaml
@@ -1,4 +1,4 @@
dataset: posebusters_benchmark # the dataset to use - NOTE: must be one of (`posebusters_benchmark`, `astex_diverse`, `dockgen`, `casp15`)
input_msa_dir: ${oc.env:PROJECT_ROOT}/data/${dataset}_set/${dataset}_msas # where the original MSA files are placed
output_msa_dir: ${oc.env:PROJECT_ROOT}/data/${dataset}_set/${dataset}_chai_msas # where the processed MSA files should be stored
-skip_existing: True # whether to skip processing if the output file already exists
+skip_existing: true # whether to skip processing if the output file already exists
diff --git a/configs/model/boltz_inference.yaml b/configs/model/boltz_inference.yaml
new file mode 100644
index 00000000..bbd0aea6
--- /dev/null
+++ b/configs/model/boltz_inference.yaml
@@ -0,0 +1,10 @@
+model: boltz1 # the model to use for inference - NOTE: must be one of (`boltz1`, `boltz2`)
+dataset: posebusters_benchmark # the dataset to use - NOTE: must be one of (`posebusters_benchmark`, `astex_diverse`, `dockgen`, `casp15`)
+input_dir: ${oc.env:PROJECT_ROOT}/forks/boltz/prediction_inputs/${dataset} # the input directory with which to run inference
+output_dir: ${oc.env:PROJECT_ROOT}/forks/boltz/prediction_outputs/${dataset}_${repeat_index} # the output directory to which to save the inference results
+cuda_device_index: 0 # the CUDA device to use for inference, or `null` to use CPU
+repeat_index: 1 # the repeat index to use for inference
+use_potentials: true # whether to use inference-time potentials to potentially improve pose plausibility
+skip_existing: true # whether to skip running inference if the prediction for a target already exists
+pocket_only_baseline: false # whether to run the pocket-only baseline
+max_num_inputs: null # if provided, the number of (dataset subset) inputs over which to run inference
diff --git a/configs/model/ensemble_generation.yaml b/configs/model/ensemble_generation.yaml
index eab80f89..16e3af4b 100644
--- a/configs/model/ensemble_generation.yaml
+++ b/configs/model/ensemble_generation.yaml
@@ -1,5 +1,5 @@
# General inference arguments:
-ensemble_methods: [diffdock, dynamicbind, neuralplexer, rfaa] # the methods from which to gather predictions for ensembling - NOTE: must be one of (`diffdock`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `alphafold3`, `vina`, `tulip`)
+ensemble_methods: [diffdock, dynamicbind, neuralplexer, rfaa] # the methods from which to gather predictions for ensembling - NOTE: must be one of (`diffdock`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `boltz`, `alphafold3`, `vina`, `tulip`)
generate_vina_scripts: false # whether to generate Vina scripts using other methods' binding site predictions - NOTE: `resume` must also be `true` when this is `true`, meaning other methods' predictions must have already been generated locally
rank_single_method_intrinsically: true # whether to rank single-method predictions using either `consensus` or `vina` ranking (false) or instead using their intrinsic (explicit) rank assignment (true)
output_bash_file_dir: ensemble_generation_scripts # the directory in which to save the generated Bash scripts
@@ -146,6 +146,9 @@ rfaa_inference_dir_name: null # the name of the inference output directory to us
# Chai-1 inference arguments:
chai_out_path: ${oc.env:PROJECT_ROOT}/forks/chai-lab/inference/chai-lab_ensemble_outputs # the output directory to which to write the predictions
chai_skip_existing: true # whether to skip running inference if the prediction for a target already exists
+# Boltz inference arguments:
+boltz_out_path: ${oc.env:PROJECT_ROOT}/forks/boltz/inference/boltz_ensemble_outputs # the output directory to which to write the predictions
+boltz_skip_existing: true # whether to skip running inference if the prediction for a target already exists
# AlphaFold 3 inference arguments:
alphafold3_out_path: ${oc.env:PROJECT_ROOT}/forks/alphafold3/inference/alphafold3_ensemble_outputs # the output directory to which to write the predictions
# Vina inference arguments:
diff --git a/configs/model/inference_relaxation.yaml b/configs/model/inference_relaxation.yaml
index 59babf23..82592c48 100644
--- a/configs/model/inference_relaxation.yaml
+++ b/configs/model/inference_relaxation.yaml
@@ -1,5 +1,5 @@
-method: diffdock # the method for which to relax predictions - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `alphafold3`, `vina`, `tulip`)
-vina_binding_site_method: p2rank # the method to use for Vina binding site prediction - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `alphafold3`, `p2rank`)
+method: diffdock # the method for which to relax predictions - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `boltz`, `alphafold3`, `vina`, `tulip`)
+vina_binding_site_method: p2rank # the method to use for Vina binding site prediction - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `boltz`, `alphafold3`, `p2rank`)
dataset: posebusters_benchmark # the dataset for which to relax predictions - NOTE: must be one of (`posebusters_benchmark`, `astex_diverse`, `dockgen`, `casp15`)
ensemble_ranking_method: consensus # the method with which to rank-order and select the top ensemble prediction for each target - NOTE: must be one of (`consensus`, `ff`)
num_processes: 1 # the number of parallel processes to use for relaxation
diff --git a/configs/scripts/benchmark_baseline_compute_resources.yaml b/configs/scripts/benchmark_baseline_compute_resources.yaml
index ed60a9fd..ac6650c1 100644
--- a/configs/scripts/benchmark_baseline_compute_resources.yaml
+++ b/configs/scripts/benchmark_baseline_compute_resources.yaml
@@ -1,5 +1,5 @@
-method: diffdock # the method for which to score predictions - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `vina`, `ensemble`)
-vina_binding_site_method: p2rank # the method to use for Vina binding site prediction - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `p2rank`)
+method: diffdock # the method for which to score predictions - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `boltz`, `vina`, `ensemble`)
+vina_binding_site_method: p2rank # the method to use for Vina binding site prediction - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `boltz`, `p2rank`)
dataset: astex_diverse # the dataset to use - NOTE: must be one of (`posebusters_benchmark`, `astex_diverse`, `dockgen`, `casp15`)
repeat_index: 1 # the repeat index which was used for inference
max_num_inputs: 21 # the number of (dataset subset) inputs over which to benchmark each baseline method's compute resource usage
diff --git a/configs/scripts/build_inference_script.yaml b/configs/scripts/build_inference_script.yaml
index 19398849..8cd637dd 100644
--- a/configs/scripts/build_inference_script.yaml
+++ b/configs/scripts/build_inference_script.yaml
@@ -1,6 +1,6 @@
# run arguments:
-method: diffdock # the method for which to score predictions - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `vina`, `ensemble`)
-vina_binding_site_method: p2rank # the method to use for Vina binding site prediction - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `p2rank`)
+method: diffdock # the method for which to score predictions - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `boltz`, `vina`, `ensemble`)
+vina_binding_site_method: p2rank # the method to use for Vina binding site prediction - NOTE: must be one of (`diffdock`, `fabind`, `dynamicbind`, `neuralplexer`, `flowdock`, `rfaa`, `chai-lab`, `boltz`, `p2rank`)
ensemble_ranking_method: consensus # the method to use for ensemble ranking - NOTE: must be one of (`consensus`, `ff`)
dataset: astex_diverse # the dataset to use - NOTE: must be one of (`posebusters_benchmark`, `astex_diverse`, `dockgen`, `casp15`)
repeat_index: 1 # the repeat index which was used for inference
@@ -22,6 +22,7 @@ methods_to_sweep: [
"flowdock",
"rfaa",
"chai-lab",
+ "boltz",
"vina",
"ensemble",
] # the methods to sweep
diff --git a/docs/source/data_preparation.rst b/docs/source/data_preparation.rst
index 0f220b84..51f0cb01 100644
--- a/docs/source/data_preparation.rst
+++ b/docs/source/data_preparation.rst
@@ -6,4 +6,4 @@ How to prepare `PoseBench` data
:end-line: 319
.. note::
- The preprocessed Astex Diverse, PoseBusters Benchmark, DockGen, and CASP15 data (available via Zenodo at https://doi.org/10.5281/zenodo.14629652) provide pre-holo-aligned protein structures predicted by AlphaFold 3 (and alternatively MIT-licensed ESMFold) for these respective datasets. Accordingly, users must ensure their usage of such predicted protein structures from AlphaFold 3 aligns with AlphaFold 3's Terms of Use at https://github.com/google-deepmind/alphafold3/blob/main/WEIGHTS_TERMS_OF_USE.md.
+ The preprocessed Astex Diverse, PoseBusters Benchmark, DockGen, and CASP15 data (available via Zenodo at https://doi.org/10.5281/zenodo.16791095) provide pre-holo-aligned protein structures predicted by AlphaFold 3 (and alternatively MIT-licensed ESMFold) for these respective datasets. Accordingly, users must ensure their usage of such predicted protein structures from AlphaFold 3 aligns with AlphaFold 3's Terms of Use at https://github.com/google-deepmind/alphafold3/blob/main/WEIGHTS_TERMS_OF_USE.md.
diff --git a/environments/boltz_environment.yaml b/environments/boltz_environment.yaml
new file mode 100644
index 00000000..755d36da
--- /dev/null
+++ b/environments/boltz_environment.yaml
@@ -0,0 +1,127 @@
+name: boltz
+channels:
+ - conda-forge
+dependencies:
+ - _libgcc_mutex=0.1=conda_forge
+ - _openmp_mutex=4.5=2_gnu
+ - bzip2=1.0.8=h4bc722e_7
+ - ca-certificates=2025.7.14=hbd8a1cb_0
+ - icu=75.1=he02047a_0
+ - ld_impl_linux-64=2.44=h1423503_1
+ - libexpat=2.7.1=hecca717_0
+ - libffi=3.4.6=h2dba641_1
+ - libgcc=15.1.0=h767d61c_4
+ - libgcc-ng=15.1.0=h69a702a_4
+ - libgomp=15.1.0=h767d61c_4
+ - liblzma=5.8.1=hb9d3cd8_2
+ - libnsl=2.0.1=hb9d3cd8_1
+ - libsqlite=3.50.3=hee844dc_1
+ - libstdcxx=15.1.0=h8f9b012_4
+ - libstdcxx-ng=15.1.0=h4852527_4
+ - libuuid=2.38.1=h0b41bf4_0
+ - libxcrypt=4.4.36=hd590300_1
+ - libzlib=1.3.1=hb9d3cd8_2
+ - ncurses=6.5=h2d0b736_3
+ - openssl=3.5.1=h7b32b05_0
+ - pip=25.1.1=pyh8b19718_0
+ - python=3.10.18=hd6af730_0_cpython
+ - readline=8.2=h8c095d6_2
+ - setuptools=80.9.0=pyhff2d567_0
+ - tk=8.6.13=noxft_hd72426e_102
+ - wheel=0.45.1=pyhd8ed1ab_1
+ - pip:
+ - aiohappyeyeballs==2.6.1
+ - aiohttp==3.12.15
+ - aiosignal==1.4.0
+ - antlr4-python3-runtime==4.9.3
+ - async-timeout==5.0.1
+ - attrs==25.3.0
+ - biopython==1.84
+ - certifi==2025.7.14
+ - charset-normalizer==3.4.2
+ - chembl-structure-pipeline==1.2.2
+ - click==8.1.7
+ - cuequivariance==0.5.1
+ - cuequivariance-ops-cu12==0.5.1
+ - cuequivariance-ops-torch-cu12==0.5.1
+ - cuequivariance-torch==0.5.1
+ - dm-tree==0.1.8
+ - docker-pycreds==0.4.0
+ - einops==0.8.0
+ - einx==0.3.0
+ - fairscale==0.4.13
+ - filelock==3.18.0
+ - frozendict==2.4.6
+ - frozenlist==1.7.0
+ - fsspec==2025.7.0
+ - gemmi==0.6.5
+ - gitdb==4.0.12
+ - gitpython==3.1.45
+ - hydra-core==1.3.2
+ - idna==3.10
+ - ihm==2.7
+ - jinja2==3.1.6
+ - joblib==1.5.1
+ - lightning-utilities==0.15.0
+ - llvmlite==0.44.0
+ - markupsafe==3.0.2
+ - mashumaro==3.14
+ - modelcif==1.2
+ - mpmath==1.3.0
+ - msgpack==1.1.1
+ - multidict==6.6.3
+ - networkx==3.4.2
+ - numba==0.61.0
+ - numpy==1.26.4
+ - nvidia-cublas-cu12==12.6.4.1
+ - nvidia-cuda-cupti-cu12==12.6.80
+ - nvidia-cuda-nvrtc-cu12==12.6.77
+ - nvidia-cuda-runtime-cu12==12.6.77
+ - nvidia-cudnn-cu12==9.5.1.17
+ - nvidia-cufft-cu12==11.3.0.4
+ - nvidia-cufile-cu12==1.11.1.6
+ - nvidia-curand-cu12==10.3.7.77
+ - nvidia-cusolver-cu12==11.7.1.2
+ - nvidia-cusparse-cu12==12.5.4.2
+ - nvidia-cusparselt-cu12==0.6.3
+ - nvidia-ml-py==12.575.51
+ - nvidia-nccl-cu12==2.26.2
+ - nvidia-nvjitlink-cu12==12.6.85
+ - nvidia-nvtx-cu12==12.6.77
+ - omegaconf==2.3.0
+ - opt-einsum==3.4.0
+ - packaging==25.0
+ - pandas==2.3.1
+ - pillow==11.3.0
+ - platformdirs==4.3.8
+ - propcache==0.3.2
+ - protobuf==5.29.5
+ - psutil==7.0.0
+ - pynvml==12.0.0
+ - python-dateutil==2.9.0.post0
+ - python-dotenv==1.1.1
+ - pytorch-lightning==2.5.0
+ - pytz==2025.2
+ - pyyaml==6.0.2
+ - rdkit==2025.3.3
+ - requests==2.32.3
+ - rootutils==1.0.7
+ - scikit-learn==1.6.1
+ - scipy==1.13.1
+ - sentry-sdk==2.34.1
+ - setproctitle==1.3.6
+ - six==1.17.0
+ - smmap==5.0.2
+ - sympy==1.14.0
+ - threadpoolctl==3.6.0
+ - torch==2.7.1
+ - torchmetrics==1.8.0
+ - tqdm==4.67.1
+ - triton==3.3.1
+ - types-requests==2.32.4.20250611
+ - typing-extensions==4.14.1
+ - tzdata==2025.2
+ - urllib3==2.5.0
+ - wandb==0.18.7
+ - yarl==1.20.1
+prefix: forks/boltz/boltz
diff --git a/environments/chai_lab_environment.yaml b/environments/chai_lab_environment.yaml
index 13a309e0..ad034fda 100644
--- a/environments/chai_lab_environment.yaml
+++ b/environments/chai_lab_environment.yaml
@@ -93,6 +93,7 @@ dependencies:
- mpmath==1.3.0
- msgpack==1.1.0
- multidict==6.1.0
+ - multimethod==1.9
- mypy==1.11.2
- mypy-extensions==1.0.0
- nest-asyncio==1.6.0
diff --git a/environments/flowdock_environment.yaml b/environments/flowdock_environment.yaml
index fff5886d..395de7cd 100644
--- a/environments/flowdock_environment.yaml
+++ b/environments/flowdock_environment.yaml
@@ -431,7 +431,7 @@ dependencies:
- msgpack-numpy==0.4.8
- numpy==1.23.5
- git+https://github.com/amorehead/openfold.git@fe1275099639bf7e617e09ef24d6af778647dd64
- - git+https://github.com/amorehead/posebusters.git@posebench
+ - git+https://github.com/amorehead/posebusters.git@posebench-0.7.0
- git+https://git@github.com/zrqiao/power_spherical.git@290b1630c5f84e3bb0d61711046edcf6e47200d4
- prody==2.4.1
- protobuf==4.25.3
diff --git a/environments/posebench_environment.yaml b/environments/posebench_environment.yaml
index 0b4502bf..169be858 100644
--- a/environments/posebench_environment.yaml
+++ b/environments/posebench_environment.yaml
@@ -8,17 +8,22 @@ channels:
dependencies:
- _libgcc_mutex=0.1=conda_forge
- _openmp_mutex=4.5=2_kmp_llvm
+ - aiohappyeyeballs=2.6.1=pyhd8ed1ab_0
- alsa-lib=1.1.5=h516909a_1002
- ambertools=23.3=py310h05519df_6
- annotated-types=0.7.0=pyhd8ed1ab_0
- antlr-python-runtime=4.9.3=pyhd8ed1ab_1
+ - aom=3.5.0=h27087fc_0
+ - argcomplete=3.6.2=pyhd8ed1ab_0
- argon2-cffi=23.1.0=pyhd8ed1ab_0
- argon2-cffi-bindings=21.2.0=py310h2372a71_4
+ - aria2=1.36.0=h43d1f13_4
- arpack=3.8.0=nompi_h0baa96a_101
- arrow=1.3.0=pyhd8ed1ab_0
- astunparse=1.6.3=pyhd8ed1ab_0
- async-lru=2.0.4=pyhd8ed1ab_0
- attrs=23.2.0=pyh71513ae_0
+ - autopep8=2.3.2=pyhd8ed1ab_0
- babel=2.14.0=pyhd8ed1ab_0
- beautifulsoup4=4.12.3=pyha770c72_0
- binutils=2.39=hdd6e379_1
@@ -30,6 +35,7 @@ dependencies:
- blosc=1.21.5=hc2324a3_1
- boost=1.82.0=h17c5347_6
- boost-cpp=1.82.0=h44aadfe_6
+ - boto=2.49.0=pyhd8ed1ab_1
- brotli=1.1.0=hd590300_1
- brotli-bin=1.1.0=hd590300_1
- brotli-python=1.1.0=py310hc6cd4ac_1
@@ -38,15 +44,18 @@ dependencies:
- c-ares=1.28.1=hd590300_0
- c-blosc2=2.14.4=hb4ffafa_1
- c-compiler=1.5.0=h166bdaf_0
- - ca-certificates=2024.12.14=hbcca054_0
+ - ca-certificates=2025.8.3=hbd8a1cb_0
- cached-property=1.5.2=hd8ed1ab_1
- cached_property=1.5.2=pyha770c72_1
- cachetools=5.3.3=pyhd8ed1ab_0
- cairo=1.18.0=h3faef2a_0
- - certifi=2024.12.14=pyhd8ed1ab_0
+ - certifi=2025.8.3=pyhd8ed1ab_0
- cffi=1.16.0=py310h2fee648_0
- charset-normalizer=3.3.2=pyhd8ed1ab_0
+ - codespell=2.4.1=pyhd8ed1ab_0
- colorama=0.4.6=pyhd8ed1ab_0
+ - crcmod=1.7=py310ha75aee5_1011
+ - cryptography=43.0.3=py310h6c63255_0
- cuda-cudart=11.8.89=0
- cuda-cupti=11.8.87=0
- cuda-libraries=11.8.0=0
@@ -58,12 +67,14 @@ dependencies:
- cxx-compiler=1.5.0=h924138e_0
- cycler=0.12.1=pyhd8ed1ab_0
- cython=3.0.10=py310hc6cd4ac_0
+ - dav1d=1.2.1=hd590300_0
- debugpy=1.8.1=py310hc6cd4ac_0
- decorator=5.1.1=pyhd8ed1ab_0
- defusedxml=0.7.1=pyhd8ed1ab_0
- entrypoints=0.4=pyhd8ed1ab_0
- exceptiongroup=1.2.0=pyhd8ed1ab_2
- expat=2.6.2=h59595ed_0
+ - fasteners=0.19=pyhd8ed1ab_1
- ffmpeg=4.3=hf484d3e_0
- fftw=3.3.10=nompi_hc118613_108
- filelock=3.14.0=pyhd8ed1ab_0
@@ -76,22 +87,34 @@ dependencies:
- fonts-conda-forge=1=0
- fqdn=1.5.1=pyhd8ed1ab_0
- freetype=2.12.1=h267a509_2
+ - fribidi=1.0.10=h36c2ea0_0
+ - gawk=5.3.1=hcd3d067_0
- gcc=10.4.0=hb92f740_13
- gcc_impl_linux-64=10.4.0=h5231bdf_19
- gcc_linux-64=10.4.0=h9215b83_13
+ - gcs-oauth2-boto-plugin=3.3=pyhd8ed1ab_0
+ - gettext=0.22.5=he02047a_3
+ - gettext-tools=0.22.5=he02047a_3
- giflib=5.2.2=hd590300_0
- gmp=6.3.0=h59595ed_1
- gmpy2=2.1.5=py310hc7909c9_1
- gnutls=3.6.13=h85f3911_1
+ - google-apitools=0.5.32=pyhd8ed1ab_1
+ - google-auth-httplib2=0.2.0=pyhd8ed1ab_1
+ - google-reauth=0.1.1=pyhd8ed1ab_1
+ - graphite2=1.3.13=h59595ed_1003
+ - gsutil=5.35=pyhd8ed1ab_0
- gxx=10.4.0=hb92f740_13
- gxx_impl_linux-64=10.4.0=h5231bdf_19
- gxx_linux-64=10.4.0=h6e491c6_13
- h11=0.14.0=pyhd8ed1ab_0
- h2=4.1.0=pyhd8ed1ab_0
+ - harfbuzz=9.0.0=hfac3d4d_0
- hdf4=4.2.15=h9772cbc_5
- hdf5=1.14.3=nompi_hdf9ad27_102
- hpack=4.0.0=pyh9f0ad1d_0
- httpcore=1.0.5=pyhd8ed1ab_0
+ - httplib2=0.20.4=pyhd8ed1ab_0
- httpx=0.27.0=pyhd8ed1ab_0
- hydra-core=1.3.2=pyhd8ed1ab_0
- hyperframe=6.0.1=pyhd8ed1ab_0
@@ -100,7 +123,6 @@ dependencies:
- importlib-metadata=7.1.0=pyha770c72_0
- importlib_metadata=7.1.0=hd8ed1ab_0
- importlib_resources=6.4.0=pyhd8ed1ab_0
- - ipywidgets=8.1.3=pyhd8ed1ab_0
- isoduration=20.11.0=pyhd8ed1ab_0
- jinja2=3.1.4=pyhd8ed1ab_0
- joblib=1.4.2=pyhd8ed1ab_1
@@ -119,7 +141,6 @@ dependencies:
- jupyterlab=4.2.1=pyhd8ed1ab_0
- jupyterlab_pygments=0.3.0=pyhd8ed1ab_1
- jupyterlab_server=2.27.2=pyhd8ed1ab_0
- - jupyterlab_widgets=3.0.11=pyhd8ed1ab_0
- kernel-headers_linux-64=2.6.32=he073ed8_17
- keyutils=1.6.1=h166bdaf_0
- kiwisolver=1.4.5=py310hd41b1e2_1
@@ -129,6 +150,9 @@ dependencies:
- ld_impl_linux-64=2.39=hcc3a1bd_1
- lerc=3.0=h9c3ff4c_0
- libaec=1.1.3=h59595ed_0
+ - libasprintf=0.22.5=he8f35ee_3
+ - libasprintf-devel=0.22.5=he8f35ee_3
+ - libass=0.17.1=h8fe9dca_1
- libblas=3.9.0=16_linux64_mkl
- libboost=1.82.0=h6fcfa73_6
- libboost-devel=1.82.0=h00ab1b0_6
@@ -147,6 +171,7 @@ dependencies:
- libcusolver=11.4.1.48=0
- libcusparse=11.7.5.86=0
- libdeflate=1.10=h7f98852_0
+ - libdrm=2.4.124=hb9d3cd8_0
- libedit=3.1.20191231=he28a2e2_2
- libev=4.33=hd590300_2
- libexpat=2.6.2=h59595ed_0
@@ -154,12 +179,15 @@ dependencies:
- libgcc=14.2.0=h77fa898_1
- libgcc-devel_linux-64=10.4.0=hd38fd1e_19
- libgcc-ng=14.2.0=h69a702a_1
+ - libgettextpo=0.22.5=he02047a_3
+ - libgettextpo-devel=0.22.5=he02047a_3
- libgfortran-ng=13.2.0=h69a702a_0
- libgfortran5=13.2.0=ha4646dd_0
- libglib=2.80.2=hf974151_0
- libgomp=14.2.0=h77fa898_1
- libhwloc=2.10.0=default_h5622ce7_1001
- libiconv=1.17=hd590300_2
+ - libidn2=2.3.7=hd590300_0
- libjpeg-turbo=2.0.0=h9bf148f_0
- liblapack=3.9.0=16_linux64_mkl
- liblapacke=3.9.0=16_linux64_mkl
@@ -168,6 +196,8 @@ dependencies:
- libnpp=11.8.0.86=0
- libnsl=2.0.1=hd590300_0
- libnvjpeg=11.9.0.86=0
+ - libopus=1.3.1=h7f98852_1
+ - libpciaccess=0.18=hd590300_0
- libpng=1.6.43=h2797004_0
- libsanitizer=10.4.0=h5246dfb_19
- libsodium=1.0.18=h36c2ea0_1
@@ -176,8 +206,12 @@ dependencies:
- libstdcxx=14.2.0=hc0a3c3a_1
- libstdcxx-devel_linux-64=10.4.0=hd38fd1e_19
- libstdcxx-ng=13.2.0=hc0a3c3a_7
+ - libtasn1=4.19.0=h166bdaf_0
- libtiff=4.3.0=h0fcbabc_4
+ - libunistring=0.9.10=h7f98852_0
- libuuid=2.38.1=h0b41bf4_0
+ - libva=2.18.0=h0b41bf4_0
+ - libvpx=1.13.1=h59595ed_0
- libwebp-base=1.4.0=hd590300_0
- libxcb=1.15=h0b41bf4_0
- libxcrypt=4.4.36=hd590300_1
@@ -188,20 +222,25 @@ dependencies:
- llvm-openmp=15.0.7=h0cdce71_0
- lz4-c=1.9.4=hcb278e6_0
- lzo=2.10=hd590300_1001
+ - markdown-it-py=3.0.0=pyhd8ed1ab_1
- markupsafe=2.1.5=py310h2372a71_0
- matplotlib-base=3.8.4=py310hef631a5_2
- matplotlib-inline=0.1.7=pyhd8ed1ab_0
- mda-xdrlib=0.2.0=pyhd8ed1ab_0
+ - mdformat=0.7.22=pyhd8ed1ab_0
- mdtraj=1.9.9=py310h523e8d7_1
+ - mdurl=0.1.2=pyhd8ed1ab_1
- mkl=2022.1.0=h84fe81f_915
- mkl-devel=2022.1.0=ha770c72_916
- mkl-include=2022.1.0=h84fe81f_915
# - mmseqs2=17.b804f=hd6d6fdc_1 # NOTE: This package is only required for failure mode analyses
+ - monotonic=1.6=pyhd8ed1ab_0
- mpc=1.3.1=hfe3b2da_0
- mpfr=4.2.1=h9458935_1
- munkres=1.1.4=pyh9f0ad1d_0
- nbclient=0.10.0=pyhd8ed1ab_0
- nbformat=5.10.4=pyhd8ed1ab_0
+ - nbqa=1.9.0=pyhd8ed1ab_0
- ncurses=6.5=h59595ed_0
- nest-asyncio=1.6.0=pyhd8ed1ab_0
- netcdf-fortran=4.6.1=nompi_hacb5139_103
@@ -211,6 +250,7 @@ dependencies:
- notebook-shim=0.2.4=pyhd8ed1ab_0
- numexpr=2.7.3=py310hb5077e9_1
- numpy=1.26.4=py310hb13e2d6_0
+ - oauth2client=4.1.3=pyhd8ed1ab_1
- ocl-icd=2.3.2=hd590300_1
- ocl-icd-system=1.0.0=1
- olefile=0.47=pyhd8ed1ab_0
@@ -230,8 +270,9 @@ dependencies:
- openjpeg=2.5.0=h7d73246_0
- openmm=8.1.1=py310h43b6314_1
- openmmforcefields=0.14.1=pyhd8ed1ab_0
- - openssl=3.4.0=hb9d3cd8_0
+ - openssl=3.5.2=h26f9b46_0
- overrides=7.7.0=pyhd8ed1ab_0
+ - p11-kit=0.24.1=hc5aa10d_0
- packmol=20.14.4=ha36c22a_0
- pandocfilters=1.5.0=pyhd8ed1ab_0
- panedr=0.8.0=pyhd8ed1ab_0
@@ -248,16 +289,21 @@ dependencies:
- pkgutil-resolve-name=1.3.10=pyhd8ed1ab_1
- platformdirs=4.2.2=pyhd8ed1ab_0
- prometheus_client=0.20.0=pyhd8ed1ab_0
+ - propcache=0.3.1=py310h89163eb_0
- psutil=5.9.8=py310h2372a71_0
- pthread-stubs=0.4=h36c2ea0_1001
- ptyprocess=0.7.0=pyhd3deb0d_0
- pure_eval=0.2.2=pyhd8ed1ab_0
- py-cpuinfo=9.0.0=pyhd8ed1ab_0
+ - pyasn1=0.6.1=pyhd8ed1ab_2
+ - pyasn1-modules=0.4.2=pyhd8ed1ab_0
- pycairo=1.26.0=py310hda9f760_0
+ - pycodestyle=2.12.1=pyhd8ed1ab_1
- pycparser=2.22=pyhd8ed1ab_0
- pydantic-core=2.18.3=py310he421c4c_0
- pyedr=0.8.0=pyhd8ed1ab_0
- pygments=2.18.0=pyhd8ed1ab_0
+ - pyopenssl=24.2.1=pyhd8ed1ab_2
- pyparsing=3.1.1=pyhd8ed1ab_0
- pysocks=1.7.1=pyha2e5f31_6
- pytables=3.9.2=py310hd76cd5d_2
@@ -271,30 +317,34 @@ dependencies:
- pytorch=2.3.0=py3.10_cuda11.8_cudnn8.7.0_0
- pytorch-cuda=11.8=h7e8668a_5
- pytorch-mutex=1.0=cuda
+ - pyu2f=0.1.5=pyhd8ed1ab_1
- pyyaml=6.0.1=py310h2372a71_1
- - rdkit=2023.09.6=py310hb79e901_1
- readline=8.2=h8228510_1
- reduce=4.14=py310h8ea774a_3
- referencing=0.35.1=pyhd8ed1ab_0
- reportlab=3.5.68=py310h94fcab3_1
- requests=2.32.3=pyhd8ed1ab_1
+ - retry_decorator=1.1.1=pyhd8ed1ab_1
- rfc3339-validator=0.1.4=pyhd8ed1ab_0
- rfc3986-validator=0.1.1=pyh9f0ad1d_0
- rpds-py=0.18.1=py310he421c4c_0
- send2trash=1.8.3=pyh0d859eb_0
- setuptools=70.0.0=pyhd8ed1ab_0
- - six=1.16.0=pyh6c4a22f_0
+ - shellcheck=0.10.0=ha770c72_0
+ - six=1.17.0=pyhe01879c_1
- smirnoff99frosst=1.1.0=pyh44b312d_0
- snappy=1.2.0=hdb0a2a9_1
- sniffio=1.3.1=pyhd8ed1ab_0
- soupsieve=2.5=pyhd8ed1ab_1
- stack_data=0.6.2=pyhd8ed1ab_0
+ - svt-av1=1.6.0=h59595ed_0
- sysroot_linux-64=2.12=he073ed8_17
- tbb=2021.12.0=h297d8ca_1
- terminado=0.18.1=pyh0d859eb_0
- tinycss2=1.3.0=pyhd8ed1ab_0
- tinydb=4.8.0=pyhd8ed1ab_0
- tk=8.6.13=noxft_h4845f30_101
+ - tokenize-rt=6.1.0=pyhd8ed1ab_1
- tomli=2.0.1=pyhd8ed1ab_0
- torchaudio=2.3.0=py310_cu118
- torchtriton=2.3.0=py310
@@ -316,7 +366,8 @@ dependencies:
- webencodings=0.5.1=pyhd8ed1ab_2
- websocket-client=1.8.0=pyhd8ed1ab_0
- wheel=0.43.0=pyhd8ed1ab_1
- - widgetsnbextension=4.0.11=pyhd8ed1ab_0
+ - x264=1!164.3095=h166bdaf_2
+ - x265=3.5=h924138e_3
- xmltodict=0.13.0=pyhd8ed1ab_0
- xorg-fixesproto=5.0=h7f98852_1002
- xorg-inputproto=2.3.2=h7f98852_1002
@@ -360,18 +411,23 @@ dependencies:
- biopandas==0.5.1.dev0
- biopython==1.79
- bioservices==1.11.2
+ - biotite==1.2.0
+ - biotraj==1.2.2
- boto3==1.28.66
- botocore==1.31.66
- cattrs==23.1.2
- cfgv==3.4.0
+ - cli-exit-tools==1.2.7
- click==8.1.7
- cliff==4.3.0
+ - cloudpathlib==0.21.1
- cmaes==0.10.0
- cmd2==2.4.3
- colorlog==6.7.0
- comm==0.2.0
- contextlib2==21.6.0
- contourpy==1.1.0
+ - cramjam==2.9.1
- datamol==0.12.4
- deepspeed==0.9.4
- dill==0.3.8
@@ -380,22 +436,34 @@ dependencies:
- dm-tree==0.1.8
- docker-pycreds==0.4.0
- docutils==0.20.1
+ - duckdb==1.3.2
- easydev==0.12.1
- edgembar==0.2
- einops==0.6.1
+ - eval-type-backport==0.2.2
- executing==1.2.0
- fair-esm==2.0.0
- fastapi==0.104.0
- fastcore==1.5.29
- - fasteners==0.19
+ - fastparquet==2024.11.0
- fonttools==4.42.1
- frozenlist==1.4.0
- - fsspec==2023.12.0
+ - fsspec==2025.7.0
- furo==2024.5.6
+ - future==1.0.0
+ - gcsfs==2025.7.0
- gemmi==0.6.7
- gevent==23.9.1
- gitdb==4.0.10
- gitpython==3.1.32
+ - google-api-core==2.25.1
+ - google-auth==2.40.3
+ - google-auth-oauthlib==1.2.2
+ - google-cloud-core==2.4.3
+ - google-cloud-storage==3.2.0
+ - google-crc32c==1.7.1
+ - google-resumable-media==2.7.2
+ - googleapis-common-protos==1.70.0
- greenlet==2.0.2
- grequests==0.7.0
- griddataformats==1.0.2
@@ -408,9 +476,13 @@ dependencies:
- ipdb==0.13.13
- ipykernel==6.27.1
- ipython==8.18.0
+ - ipython-genutils==0.2.0
+ - ipywidgets==7.8.5
- jaxtyping==0.2.21
- jedi==0.19.0
- jmespath==1.0.1
+ - jupyterlab-widgets==1.1.11
+ - lib-detect-testenv==2.0.8
- lightning==2.1.3
- lightning-cloud==0.5.61
- lightning-utilities==0.10.0
@@ -421,15 +493,15 @@ dependencies:
- lxml==4.9.3
- m2r2==0.3.3.post2
- mako==1.2.4
- - markdown-it-py==3.0.0
- mdahole2==0.5.0
- mdanalysis==2.8.0
- - mdurl==0.1.2
- git+https://github.com/amorehead/Meeko.git@patch-1
- mistune==0.8.4
- ml-collections==0.1.1
+ - mmcif==0.92.0
- mmpbsa-py==16.0
- mmtf-python==1.1.3
+ - mols2grid==2.0.0
- mpmath==1.2.1
- mrcfile==1.5.0
- msgpack==1.0.8
@@ -442,11 +514,12 @@ dependencies:
- nglview==3.0.8
- ninja==1.11.1
- nodeenv==1.9.0
+ - oauthlib==3.3.1
- git+https://github.com/amorehead/openfold.git@4ef71646ed031f69716097a9352d21778369136d
- opt-einsum==3.3.0
- opt-einsum-fx==0.1.4
- optuna==2.10.1
- - packaging==21.3
+ - packaging==25.0
- packmol-memgen==2023.2.24
- pandas==1.5.0
- pandoc==2.3
@@ -458,17 +531,19 @@ dependencies:
- pdb4amber==22.0
- pdbeccdutils==0.8.6
- pillow==10.4.0
+ - git+https://github.com/amorehead/plinder.git@posebench
- plotly==5.17.0
- plumbum==1.8.3
- ply==3.11
- poethepoet==0.10.0
- - git+https://github.com/amorehead/posebusters.git@posebench
+ - git+https://github.com/amorehead/posebusters.git@posebench-0.7.0
- git+https://github.com/amorehead/posecheck.git@posebench
- pot==0.9.1
- pre-commit==3.6.2
- prettytable==3.8.0
- git+https://github.com/amorehead/ProLIF.git@patch-2
- prompt-toolkit==3.0.39
+ - proto-plus==1.26.1
- protobuf==4.24.1
- pyaml==21.10.1
- pyarrow==18.1.0
@@ -484,16 +559,19 @@ dependencies:
- pytraj==2.0.6
- pytz==2022.4
- pyzmq==25.1.1
+ - rdkit==2025.3.5
- regex==2023.10.3
- requests-cache==1.1.0
+ - requests-oauthlib==2.0.0
- rich==13.7.1
- rich-click==1.6.1
- roma==1.4.1
- rootutils==1.0.7
+ - rsa==4.9.1
- s3transfer==0.7.0
- sander==22.0
- scikit-learn==1.1.2
- - scipy==1.15.1
+ - scipy==1.9.1
- seaborn==0.12.2
- selfies==2.1.1
- sentry-sdk==1.29.2
@@ -530,6 +608,7 @@ dependencies:
- waterdynamics==1.2.0
- watermark==2.4.3
- wget==3.2
+ - widgetsnbextension==3.6.10
- wrapt==1.15.0
- wrapt_timeout_decorator==1.5.1
- xarray==2023.8.0
diff --git a/environments/rfaa_environment.yaml b/environments/rfaa_environment.yaml
index 2db807c4..f7f910a2 100644
--- a/environments/rfaa_environment.yaml
+++ b/environments/rfaa_environment.yaml
@@ -469,7 +469,7 @@ dependencies:
- pandas==2.2.2
- pathtools==0.1.2
- pdb4amber==22.0
- - git+https://github.com/amorehead/posebusters.git@posebench
+ - git+https://github.com/amorehead/posebusters.git@posebench-0.7.0
- prody==2.4.1
- promise==2.3
- pynvml==11.0.0
diff --git a/forks/boltz/.gitignore b/forks/boltz/.gitignore
new file mode 100644
index 00000000..3d20fc11
--- /dev/null
+++ b/forks/boltz/.gitignore
@@ -0,0 +1,166 @@
+# Byte-compiled / optimized / DLL files
+__pycache__/
+*.py[cod]
+*$py.class
+
+# C extensions
+*.so
+
+# Distribution / packaging
+.Python
+build/
+develop-eggs/
+dist/
+downloads/
+eggs/
+.eggs/
+lib/
+lib64/
+parts/
+sdist/
+var/
+wheels/
+share/python-wheels/
+*.egg-info/
+.installed.cfg
+*.egg
+MANIFEST
+
+# PyInstaller
+# Usually these files are written by a python script from a template
+# before PyInstaller builds the exe, so as to inject date/other infos into it.
+*.manifest
+*.spec
+
+# Installer logs
+pip-log.txt
+pip-delete-this-directory.txt
+
+# Unit test / coverage reports
+htmlcov/
+.tox/
+.nox/
+.coverage
+.coverage.*
+.cache
+nosetests.xml
+coverage.xml
+*.cover
+*.py,cover
+.hypothesis/
+.pytest_cache/
+cover/
+
+# Translations
+*.mo
+*.pot
+
+# Django stuff:
+*.log
+local_settings.py
+db.sqlite3
+db.sqlite3-journal
+
+# Flask stuff:
+instance/
+.webassets-cache
+
+# Scrapy stuff:
+.scrapy
+
+# Sphinx documentation
+docs/_build/
+
+# PyBuilder
+.pybuilder/
+target/
+
+# Jupyter Notebook
+.ipynb_checkpoints
+
+# IPython
+profile_default/
+ipython_config.py
+
+# pyenv
+# For a library or package, you might want to ignore these files since the code is
+# intended to run in multiple environments; otherwise, check them in:
+# .python-version
+
+# pipenv
+# According to pypa/pipenv#598, it is recommended to include Pipfile.lock in version control.
+# However, in case of collaboration, if having platform-specific dependencies or dependencies
+# having no cross-platform support, pipenv may install dependencies that don't work, or not
+# install all needed dependencies.
+#Pipfile.lock
+
+# poetry
+# Similar to Pipfile.lock, it is generally recommended to include poetry.lock in version control.
+# This is especially recommended for binary packages to ensure reproducibility, and is more
+# commonly ignored for libraries.
+# https://python-poetry.org/docs/basic-usage/#commit-your-poetrylock-file-to-version-control
+#poetry.lock
+
+# pdm
+# Similar to Pipfile.lock, it is generally recommended to include pdm.lock in version control.
+#pdm.lock
+# pdm stores project-wide configurations in .pdm.toml, but it is recommended to not include it
+# in version control.
+# https://pdm.fming.dev/latest/usage/project/#working-with-version-control
+.pdm.toml
+.pdm-python
+.pdm-build/
+
+# PEP 582; used by e.g. github.com/David-OConnor/pyflow and github.com/pdm-project/pdm
+__pypackages__/
+
+# Celery stuff
+celerybeat-schedule
+celerybeat.pid
+
+# SageMath parsed files
+*.sage.py
+
+# Environments
+.env
+.venv
+env/
+venv/
+ENV/
+env.bak/
+venv.bak/
+
+# Spyder project settings
+.spyderproject
+.spyproject
+
+# Rope project settings
+.ropeproject
+
+# mkdocs documentation
+/site
+
+# mypy
+.mypy_cache/
+.dmypy.json
+dmypy.json
+
+# Pyre type checker
+.pyre/
+
+# pytype static type analyzer
+.pytype/
+
+# Cython debug symbols
+cython_debug/
+
+# PyCharm
+# JetBrains specific template is maintained in a separate JetBrains.gitignore that can
+# be found at https://github.com/github/gitignore/blob/main/Global/JetBrains.gitignore
+# and can be added to the global gitignore or merged into this file. For a more nuclear
+# option (not recommended) you can uncomment the following to ignore the entire idea folder.
+#.idea/
+
+# Boltz prediction outputs
+# All result files generated from a boltz prediction call
+boltz_results_*/
\ No newline at end of file
diff --git a/forks/boltz/LICENSE b/forks/boltz/LICENSE
new file mode 100644
index 00000000..a9d65753
--- /dev/null
+++ b/forks/boltz/LICENSE
@@ -0,0 +1,21 @@
+MIT License
+
+Copyright (c) 2024 Jeremy Wohlwend, Gabriele Corso, Saro Passaro
+
+Permission is hereby granted, free of charge, to any person obtaining a copy
+of this software and associated documentation files (the "Software"), to deal
+in the Software without restriction, including without limitation the rights
+to use, copy, modify, merge, publish, distribute, sublicense, and/or sell
+copies of the Software, and to permit persons to whom the Software is
+furnished to do so, subject to the following conditions:
+
+The above copyright notice and this permission notice shall be included in all
+copies or substantial portions of the Software.
+
+THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR
+IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY,
+FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE
+AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER
+LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM,
+OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE
+SOFTWARE.
diff --git a/forks/boltz/README.md b/forks/boltz/README.md
new file mode 100644
index 00000000..d16a003f
--- /dev/null
+++ b/forks/boltz/README.md
@@ -0,0 +1,117 @@
+
+
+

+

+
+[Boltz-1](https://doi.org/10.1101/2024.11.19.624167) | [Boltz-2](https://doi.org/10.1101/2025.06.14.659707) |
+[Slack](https://boltz.bio/join-slack) | Commit: `ac33fe07eb8336c5046b740ffeedf1345fcb00af`
+
+
+
+
+
+
+
+## Introduction
+
+Boltz is a family of models for biomolecular interaction prediction. Boltz-1 was the first fully open source model to approach AlphaFold3 accuracy. Our latest work Boltz-2 is a new biomolecular foundation model that goes beyond AlphaFold3 and Boltz-1 by jointly modeling complex structures and binding affinities, a critical component towards accurate molecular design. Boltz-2 is the first deep learning model to approach the accuracy of physics-based free-energy perturbation (FEP) methods, while running 1000x faster — making accurate in silico screening practical for early-stage drug discovery.
+
+All the code and weights are provided under MIT license, making them freely available for both academic and commercial uses. For more information about the model, see the [Boltz-1](https://doi.org/10.1101/2024.11.19.624167) and [Boltz-2](https://doi.org/10.1101/2025.06.14.659707) technical reports. To discuss updates, tools and applications join our [Slack channel](https://boltz.bio/join-slack).
+
+## Installation
+
+> Note: we recommend installing boltz in a fresh python environment
+
+Install boltz with PyPI (recommended):
+
+```
+pip install boltz[cuda] -U
+```
+
+or directly from GitHub for daily updates:
+
+```
+git clone https://github.com/jwohlwend/boltz.git
+cd boltz; pip install -e .[cuda]
+```
+
+If you are installing on CPU-only or non-CUDA GPus hardware, remove `[cuda]` from the above commands. Note that the CPU version is significantly slower than the GPU version.
+
+## Inference
+
+You can run inference using Boltz with:
+
+```
+boltz predict input_path --use_msa_server
+```
+
+`input_path` should point to a YAML file, or a directory of YAML files for batched processing, describing the biomolecules you want to model and the properties you want to predict (e.g. affinity). To see all available options: `boltz predict --help` and for more information on these input formats, see our [prediction instructions](docs/prediction.md). By default, the `boltz` command will run the latest version of the model.
+
+
+### Binding Affinity Prediction
+There are two main predictions in the affinity output: `affinity_pred_value` and `affinity_probability_binary`. They are trained on largely different datasets, with different supervisions, and should be used in different contexts. The `affinity_probability_binary` field should be used to detect binders from decoys, for example in a hit-discovery stage. It's value ranges from 0 to 1 and represents the predicted probability that the ligand is a binder. The `affinity_pred_value` aims to measure the specific affinity of different binders and how this changes with small modifications of the molecule. This should be used in ligand optimization stages such as hit-to-lead and lead-optimization. It reports a binding affinity value as `log(IC50)`, derived from an `IC50` measured in `μM`. More details on how to run affinity predictions and parse the output can be found in our [prediction instructions](docs/prediction.md).
+
+## Authentication to MSA Server
+
+When using the `--use_msa_server` option with a server that requires authentication, you can provide credentials in one of two ways. More information is available in our [prediction instructions](docs/prediction.md).
+
+## Evaluation
+
+⚠️ **Coming soon: updated evaluation code for Boltz-2!**
+
+To encourage reproducibility and facilitate comparison with other models, on top of the existing Boltz-1 evaluation pipeline, we will soon provide the evaluation scripts and structural predictions for Boltz-2, Boltz-1, Chai-1 and AlphaFold3 on our test benchmark dataset, and our affinity predictions on the FEP+ benchmark, CASP16 and our MF-PCBA test set.
+
+
+
+
+
+## Training
+
+⚠️ **Coming soon: updated training code for Boltz-2!**
+
+If you're interested in retraining the model, currently for Boltz-1 but soon for Boltz-2, see our [training instructions](docs/training.md).
+
+
+## Contributing
+
+We welcome external contributions and are eager to engage with the community. Connect with us on our [Slack channel](https://boltz.bio/join-slack) to discuss advancements, share insights, and foster collaboration around Boltz-2.
+
+On recent NVIDIA GPUs, Boltz leverages the acceleration provided by [NVIDIA cuEquivariance](https://developer.nvidia.com/cuequivariance) kernels. Boltz also runs on Tenstorrent hardware thanks to a [fork](https://github.com/moritztng/tt-boltz) by Moritz Thüning.
+
+## License
+
+Our model and code are released under MIT License, and can be freely used for both academic and commercial purposes.
+
+
+## Cite
+
+If you use this code or the models in your research, please cite the following papers:
+
+```bibtex
+@article{passaro2025boltz2,
+ author = {Passaro, Saro and Corso, Gabriele and Wohlwend, Jeremy and Reveiz, Mateo and Thaler, Stephan and Somnath, Vignesh Ram and Getz, Noah and Portnoi, Tally and Roy, Julien and Stark, Hannes and Kwabi-Addo, David and Beaini, Dominique and Jaakkola, Tommi and Barzilay, Regina},
+ title = {Boltz-2: Towards Accurate and Efficient Binding Affinity Prediction},
+ year = {2025},
+ doi = {10.1101/2025.06.14.659707},
+ journal = {bioRxiv}
+}
+
+@article{wohlwend2024boltz1,
+ author = {Wohlwend, Jeremy and Corso, Gabriele and Passaro, Saro and Getz, Noah and Reveiz, Mateo and Leidal, Ken and Swiderski, Wojtek and Atkinson, Liam and Portnoi, Tally and Chinn, Itamar and Silterra, Jacob and Jaakkola, Tommi and Barzilay, Regina},
+ title = {Boltz-1: Democratizing Biomolecular Interaction Modeling},
+ year = {2024},
+ doi = {10.1101/2024.11.19.624167},
+ journal = {bioRxiv}
+}
+```
+
+In addition if you use the automatic MSA generation, please cite:
+
+```bibtex
+@article{mirdita2022colabfold,
+ title={ColabFold: making protein folding accessible to all},
+ author={Mirdita, Milot and Sch{\"u}tze, Konstantin and Moriwaki, Yoshitaka and Heo, Lim and Ovchinnikov, Sergey and Steinegger, Martin},
+ journal={Nature methods},
+ year={2022},
+}
+```
diff --git a/forks/boltz/docs/boltz1_pred_figure.png b/forks/boltz/docs/boltz1_pred_figure.png
new file mode 100644
index 00000000..e55f26c5
Binary files /dev/null and b/forks/boltz/docs/boltz1_pred_figure.png differ
diff --git a/forks/boltz/docs/boltz2_title.png b/forks/boltz/docs/boltz2_title.png
new file mode 100644
index 00000000..d01a8dd8
Binary files /dev/null and b/forks/boltz/docs/boltz2_title.png differ
diff --git a/forks/boltz/docs/evaluation.md b/forks/boltz/docs/evaluation.md
new file mode 100644
index 00000000..ae8f063b
--- /dev/null
+++ b/forks/boltz/docs/evaluation.md
@@ -0,0 +1,73 @@
+# Evaluation
+
+To encourage reproducibility and facilitate comparison with other models, we will provide the evaluation scripts and structural predictions for Boltz-2, Boltz-1, Chai-1 and AlphaFold3 on our test benchmark dataset, and our affinity predictions on the FEP+ benchamark, CASP16 and our MF-PCBA test set.
+
+
+
+
+
+## Evaluation files
+⚠️ **Coming soon updated evaluation files for Boltz-2!**
+
+
+## Evaluation setup
+⚠️ **Coming soon updated setup for Boltz-2!**
+
+
+## Evaluation script
+⚠️ **Coming soon updated evaluation scripts for Boltz-2!**
+
+# Evaluation
+
+To encourage reproducibility and facilitate comparison with other models, we provide the evaluation scripts and predictions for Boltz-1, Chai-1, and AlphaFold3 on our test benchmark dataset as well as CASP15. These datasets are created to contain biomolecules different from the training data and to benchmark the performance of these models we run them with the same input MSAs and the same number of recycling and diffusion steps.
+
+
+
+
+
+## (Old) Boltz-1 Evaluation files
+
+You can download all the MSAs, input files, output files and evaluation outputs for Boltz-1, Boltz-1x, Chai-1, and AlphaFold3 from this [Google Drive folder](https://drive.google.com/file/d/1JvHlYUMINOaqPTunI9wBYrfYniKgVmxf/view?usp=sharing).
+
+The files are organized as follows:
+
+```
+boltz_results_final/
+├── inputs/ # Input files for every model
+ ├── casp15/
+ ├── af3
+ ├── boltz
+ ├── boltzx
+ ├── chai
+ └── msa
+ └── test/
+├── targets/ # Target files from PDB
+ ├── casp15
+ └── test
+├── outputs/ # Output files for every model
+ ├── casp15
+ └── test
+├── evals/ # Output of evaluation script for every
+ ├── casp15
+ └── test
+├── results_casp.csv # Summary of evaluation results for CASP15
+└── results_test.csv # Summary of evaluation results for test set
+```
+
+## (Old) Boltz-1 Evaluation setup
+
+We evaluate the model on two datasets:
+ - PDB test set: 541 targets after our validation cut-off date and at most 40% sequence similarity for proteins, 80% Tanimoto for ligands.
+ - CASP15: 66 difficult targets from the CASP 2022 competition.
+
+We benchmark Boltz-1 against Chai-1 and AF3, other state-of-the-art structure prediction models, but much more closed source in terms of model code, training and data pipeline. Note that we remove overlap with our validation set, but we cannot ensure that there is no overlap with AF3 or Chai-1 validation set as those were not published.
+
+For fair comparison we compare the models with the following setup:
+ - Same MSA’s.
+ - Same parameters: 10 recycling steps, 200 sampling steps, 5 samples.
+ - We compare our oracle and top-1 numbers among the 5 samples.
+
+
+## (Old) Boltz-1 Evaluation script
+
+We also provide the scripts we used to evaluate the models and aggregate results. The evaluations were run through [OpenStructure](https://openstructure.org/docs/2.9.0/) version 2.8.0 (it is important to use the specific version for reproducing the results). You can find these scripts at `scripts/eval/run_evals.py` and `scripts/eval/aggregate_evals.py`.
diff --git a/forks/boltz/docs/pearson_plot.png b/forks/boltz/docs/pearson_plot.png
new file mode 100644
index 00000000..7c8e8ba2
Binary files /dev/null and b/forks/boltz/docs/pearson_plot.png differ
diff --git a/forks/boltz/docs/plot_test_boltz2.png b/forks/boltz/docs/plot_test_boltz2.png
new file mode 100644
index 00000000..9fd3e70b
Binary files /dev/null and b/forks/boltz/docs/plot_test_boltz2.png differ
diff --git a/forks/boltz/docs/prediction.md b/forks/boltz/docs/prediction.md
new file mode 100644
index 00000000..f6186f97
--- /dev/null
+++ b/forks/boltz/docs/prediction.md
@@ -0,0 +1,311 @@
+# Prediction
+
+Once you have installed `boltz`, you can start making predictions by simply running:
+
+`boltz predict --use_msa_server`
+
+where `` is a path to the input file or a directory. The input file can either be in fasta (enough for most use cases) or YAML format (for more complex inputs). If you specify a directory, `boltz` will run predictions on each `.yaml` or `.fasta` file in the directory. Passing the `--use_msa_server` flag will auto-generate the MSA using the mmseqs2 server, otherwise you can provide a precomputed MSA.
+
+The Boltz model includes an option to use inference time potentials that significantly improve the physical quality of the poses. If you find any physical issues with the model predictions, please let us know by opening an issue and including the YAML/FASTA file to replicate, the structure output and a description of the problem. If you want to run the Boltz model with the potentials you can do so with the `--use_potentials` flag.
+
+Before diving into more details about the input formats, here are the key differences in what they each support:
+
+| Feature | Fasta | YAML |
+| -------- |--------------------| ------- |
+| Polymers | :white_check_mark: | :white_check_mark: |
+| Smiles | :white_check_mark: | :white_check_mark: |
+| CCD code | :white_check_mark: | :white_check_mark: |
+| Custom MSA | :white_check_mark: | :white_check_mark: |
+| Modified Residues | :x: | :white_check_mark: |
+| Covalent bonds | :x: | :white_check_mark: |
+| Pocket conditioning | :x: | :white_check_mark: |
+| Affinity | :x: | :white_check_mark: |
+
+
+## YAML format
+
+The YAML format is more flexible and allows for more complex inputs, particularly around covalent bonds. The schema of the YAML is the following:
+
+```yaml
+sequences:
+ - ENTITY_TYPE:
+ id: CHAIN_ID
+ sequence: SEQUENCE # only for protein, dna, rna
+ smiles: 'SMILES' # only for ligand, exclusive with ccd
+ ccd: CCD # only for ligand, exclusive with smiles
+ msa: MSA_PATH # only for protein
+ modifications:
+ - position: RES_IDX # index of residue, starting from 1
+ ccd: CCD # CCD code of the modified residue
+ cyclic: false
+ - ENTITY_TYPE:
+ id: [CHAIN_ID, CHAIN_ID] # multiple ids in case of multiple identical entities
+ ...
+constraints:
+ - bond:
+ atom1: [CHAIN_ID, RES_IDX, ATOM_NAME]
+ atom2: [CHAIN_ID, RES_IDX, ATOM_NAME]
+ - pocket:
+ binder: CHAIN_ID
+ contacts: [[CHAIN_ID, RES_IDX/ATOM_NAME], [CHAIN_ID, RES_IDX/ATOM_NAME]]
+ max_distance: DIST_ANGSTROM
+ force: false # if force is set to true (default is false), a potential will be used to enforce the pocket constraint
+ - contact:
+ token1: [CHAIN_ID, RES_IDX/ATOM_NAME]
+ token2: [CHAIN_ID, RES_IDX/ATOM_NAME]
+ max_distance: DIST_ANGSTROM
+ force: false # if force is set to true (default is false), a potential will be used to enforce the contact constraint
+
+templates:
+ - cif: CIF_PATH # if only a path is provided, Boltz will find the best matchings
+ - cif: CIF_PATH
+ force: true # optional, if force is set to true (default is false), a potential will be used to enforce the template
+ threshold: DISTANCE_THRESHOLD # optional, controls the distance (in Angstroms) that the prediction can deviate from the template
+ - cif: CIF_PATH
+ chain_id: CHAIN_ID # optional, specify which chain to find a template for
+ - cif: CIF_PATH
+ chain_id: [CHAIN_ID, CHAIN_ID] # can be more than one
+ template_id: [TEMPLATE_CHAIN_ID, TEMPLATE_CHAIN_ID]
+properties:
+ - affinity:
+ binder: CHAIN_ID
+
+```
+
+`sequences` has one entry for every unique chain/molecule in the input. Each polymer entity as a `ENTITY_TYPE` either `protein`, `dna` or `rna` and have a `sequence` attribute. Non-polymer entities are indicated by `ENTITY_TYPE` equal to `ligand` and have a `smiles` or `ccd` attribute. `CHAIN_ID` is the unique identifier for each chain/molecule, and it should be set as a list in case of multiple identical entities in the structure. For proteins, the `msa` key is required by default but can be omitted by passing the `--use_msa_server` flag which will auto-generate the MSA using the mmseqs2 server. If you wish to use a precomputed MSA, use the `msa` attribute with `MSA_PATH` indicating the path to the `.a3m` file containing the MSA for that protein. If you wish to explicitly run single sequence mode (which is generally advised against as it will hurt model performance), you may do so by using the special keyword `empty` for that protein (ex: `msa: empty`). For custom MSA, you may wish to indicate pairing keys to the model. You can do so by using a CSV format instead of a3m with two columns: `sequence` with the protein sequences and `key` which is a unique identifier indicating matching rows across CSV files of each protein chain.
+
+The `modifications` field is an optional field that allows you to specify modified residues in the polymer (`protein`, `dna` or`rna`). The `position` field specifies the index (starting from 1) of the residue, and `ccd` is the CCD code of the modified residue. This field is currently only supported for CCD ligands. The `cyclic` flag should be used to specify polymer chains (not ligands) that are cyclic.
+
+`constraints` is an optional field that allows you to specify additional information about the input structure.
+
+
+* The `bond` constraint specifies covalent bonds between two atoms (`atom1` and `atom2`). It is currently only supported for CCD ligands and canonical residues, `CHAIN_ID` refers to the id of the residue set above, `RES_IDX` is the index (starting from 1) of the residue (1 for ligands), and `ATOM_NAME` is the standardized atom name (can be verified in CIF file of that component on the RCSB website).
+
+* The `pocket` constraint specifies the residues associated with a ligand, where `binder` refers to the chain binding to the pocket (which can be a molecule, protein, DNA or RNA) and `contacts` is the list of chain and residue indices (starting from 1) associated with the pocket. The model currently only supports the specification of a single `binder` chain (and any number of `contacts` residues in other chains).
+
+`templates` is an optional field that allows you to specify structural templates for your prediction. At minimum, you must provide the path to the structural template, which must provided as a CIF file. If you wish to explicitly define which of the chains in your YAML should be templated using this CIF file, you can use the `chain_id` entry to specify them. Whether a set of ids is provided or not, Boltz will find the best matching chains from the provided template. If you wish to explicitly define the mapping yourself, you may provide the corresponding template_id. Note that only protein chains can be templated.
+
+`properties` is an optional field that allows you to specify whether you want to compute the affinity. If enabled, you must also provide the chain_id corresponding to the small molecule against which the affinity will be computed. Only one single molecule can be specified for affinity computation, and it must be a ligand chain (not a protein, DNA or RNA).
+
+As an example:
+
+```yaml
+version: 1
+sequences:
+ - protein:
+ id: [A, B]
+ sequence: MVTPEGNVSLVDESLLVGVTDEDRAVRSAHQFYERLIGLWAPAVMEAAHELGVFAALAEAPADSGELARRLDCDARAMRVLLDALYAYDVIDRIHDTNGFRYLLSAEARECLLPGTLFSLVGKFMHDINVAWPAWRNLAEVVRHGARDTSGAESPNGIAQEDYESLVGGINFWAPPIVTTLSRKLRASGRSGDATASVLDVGCGTGLYSQLLLREFPRWTATGLDVERIATLANAQALRLGVEERFATRAGDFWRGGWGTGYDLVLFANIFHLQTPASAVRLMRHAAACLAPDGLVAVVDQIVDADREPKTPQDRFALLFAASMTNTGGGDAYTFQEYEEWFTAAGLQRIETLDTPMHRILLARRATEPSAVPEGQASENLYFQ
+ msa: ./examples/msa/seq1.a3m
+ - ligand:
+ id: [C, D]
+ ccd: SAH
+ - ligand:
+ id: [E, F]
+ smiles: 'N[C@@H](Cc1ccc(O)cc1)C(=O)O'
+```
+
+
+## Fasta format
+
+The fasta format is a little simpler, and should contain entries as follows:
+
+```
+>CHAIN_ID|ENTITY_TYPE|MSA_PATH
+SEQUENCE
+```
+
+The `CHAIN_ID` is a unique identifier for each input chain. The `ENTITY_TYPE` can be one of `protein`, `dna`, `rna`, `smiles`, `ccd` (note that we support both smiles and CCD code for ligands). The `MSA_PATH` is only applicable to proteins. By default, MSA's are required, but they can be omited by passing the `--use_msa_server` flag which will auto-generate the MSA using the mmseqs2 server. If you wish to use a custom MSA, use it to set the path to the `.a3m` file containing a pre-computed MSA for this protein. If you wish to explicitly run single sequence mode (which is generally advised against as it will hurt model performance), you may do so by using the special keyword `empty` for that protein (ex: `>A|protein|empty`). For custom MSA, you may wish to indicate pairing keys to the model. You can do so by using a CSV format instead of a3m with two columns: `sequence` with the protein sequences and `key` which is a unique identifier indicating matching rows across CSV files of each protein chain.
+
+For each of these cases, the corresponding `SEQUENCE` will contain an amino acid sequence (e.g. `EFKEAFSLF`), a sequence of nucleotide bases (e.g. `ATCG`), a smiles string (e.g. `CC1=CC=CC=C1`), or a CCD code (e.g. `ATP`), depending on the entity.
+
+As an example:
+
+```yaml
+>A|protein|./examples/msa/seq1.a3m
+MVTPEGNVSLVDESLLVGVTDEDRAVRSAHQFYERLIGLWAPAVMEAAHELGVFAALAEAPADSGELARRLDCDARAMRVLLDALYAYDVIDRIHDTNGFRYLLSAEARECLLPGTLFSLVGKFMHDINVAWPAWRNLAEVVRHGARDTSGAESPNGIAQEDYESLVGGINFWAPPIVTTLSRKLRASGRSGDATASVLDVGCGTGLYSQLLLREFPRWTATGLDVERIATLANAQALRLGVEERFATRAGDFWRGGWGTGYDLVLFANIFHLQTPASAVRLMRHAAACLAPDGLVAVVDQIVDADREPKTPQDRFALLFAASMTNTGGGDAYTFQEYEEWFTAAGLQRIETLDTPMHRILLARRATEPSAVPEGQASENLYFQ
+>B|protein|./examples/msa/seq1.a3m
+MVTPEGNVSLVDESLLVGVTDEDRAVRSAHQFYERLIGLWAPAVMEAAHELGVFAALAEAPADSGELARRLDCDARAMRVLLDALYAYDVIDRIHDTNGFRYLLSAEARECLLPGTLFSLVGKFMHDINVAWPAWRNLAEVVRHGARDTSGAESPNGIAQEDYESLVGGINFWAPPIVTTLSRKLRASGRSGDATASVLDVGCGTGLYSQLLLREFPRWTATGLDVERIATLANAQALRLGVEERFATRAGDFWRGGWGTGYDLVLFANIFHLQTPASAVRLMRHAAACLAPDGLVAVVDQIVDADREPKTPQDRFALLFAASMTNTGGGDAYTFQEYEEWFTAAGLQRIETLDTPMHRILLARRATEPSAVPEGQASENLYFQ
+>C|ccd
+SAH
+>D|ccd
+SAH
+>E|smiles
+N[C@@H](Cc1ccc(O)cc1)C(=O)O
+>F|smiles
+N[C@@H](Cc1ccc(O)cc1)C(=O)O
+```
+
+
+## Options
+
+The following options are available for the `predict` command:
+
+ boltz predict input_path [OPTIONS]
+
+As an example, to predict a structure using 10 recycling steps and 25 samples (the default parameters for AlphaFold3) use:
+
+ boltz predict input_path --recycling_steps 10 --diffusion_samples 25
+
+(note however that the prediction will take significantly longer)
+
+
+| **Option** | **Type** | **Default** | **Description** |
+|--------------------------|-----------------|-----------------------------|-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------|
+| `--out_dir` | `PATH` | `./` | The path where to save the predictions. |
+| `--cache` | `PATH` | `~/.boltz` | The directory where to download the data and model. Will use environment variable `BOLTZ_CACHE` as an absolute path if set |
+| `--checkpoint` | `PATH` | None | An optional checkpoint. Uses the provided Boltz-2 model by default. |
+| `--devices` | `INTEGER` | `1` | The number of devices to use for prediction. |
+| `--accelerator` | `[gpu,cpu,tpu]` | `gpu` | The accelerator to use for prediction. |
+| `--recycling_steps` | `INTEGER` | `3` | The number of recycling steps to use for prediction. |
+| `--sampling_steps` | `INTEGER` | `200` | The number of sampling steps to use for prediction. |
+| `--diffusion_samples` | `INTEGER` | `1` | The number of diffusion samples to use for prediction. |
+| `--max_parallel_samples` | `INTEGER` | `5` | maximum number of samples to predict in parallel. |
+| `--step_scale` | `FLOAT` | `1.638` | The step size is related to the temperature at which the diffusion process samples the distribution. The lower the higher the diversity among samples (recommended between 1 and 2). |
+| `--output_format` | `[pdb,mmcif]` | `mmcif` | The output format to use for the predictions. |
+| `--num_workers` | `INTEGER` | `2` | The number of dataloader workers to use for prediction. |
+| `--method` | str | None | The method to use for prediction. |
+| `--preprocessing-threads` | `INTEGER` | `multiprocessing.cpu_count()` | The number of threads to use for preprocessing. |
+| `--affinity_mw_correction` | `FLAG` | `False` | Whether to add the Molecular Weight correction to the affinity value head. |
+| `--sampling_steps_affinity` | `INTEGER` | `200` | The number of sampling steps to use for affinity prediction. |
+| `--diffusion_samples_affinity` | `INTEGER` | `5` | The number of diffusion samples to use for affinity prediction. |
+| `--affinity_checkpoint` | `PATH` | None | An optional checkpoint for affinity. Uses the provided Boltz-2 model by default. |
+| `--max_msa_seqs` | `INTEGER` | `8192` |The maximum number of MSA sequences to use for prediction. |
+| `--subsample_msa` | `FLAG` | `False` | Whether to subsample the MSA. |
+| `--num_subsampled_msa` | `INTEGER` | `1024` | The number of MSA sequences to subsample. |
+| `--no_kernels` | `FLAG` | `False` | Whether to not use trifast kernels for triangular updates.. |
+| `--override` | `FLAG` | `False` | Whether to override existing predictions if found. |
+| `--use_msa_server` | `FLAG` | `False` | Whether to use the msa server to generate msa's. |
+| `--msa_server_url` | str | `https://api.colabfold.com` | MSA server url. Used only if --use_msa_server is set. |
+| `--msa_pairing_strategy` | str | `greedy` | Pairing strategy to use. Used only if --use_msa_server is set. Options are 'greedy' and 'complete' |
+| `--use_potentials` | `FLAG` | `False` | Whether to run the original Boltz-2 model using inference time potentials. |
+| `--write_full_pae` | `FLAG` | `False` | Whether to save the full PAE matrix as a file. |
+| `--write_full_pde` | `FLAG` | `False` | Whether to save the full PDE matrix as a file. |
+
+## Output
+
+After running the model, the generated outputs are organized into the output directory following the structure below:
+```
+out_dir/
+├── lightning_logs/ # Logs generated during training or evaluation
+├── predictions/ # Contains the model's predictions
+ ├── [input_file1]/
+ ├── [input_file1]_model_0.cif # The predicted structure in CIF format, with the inclusion of per token pLDDT scores
+ ├── confidence_[input_file1]_model_0.json # The confidence scores (confidence_score, ptm, iptm, ligand_iptm, protein_iptm, complex_plddt, complex_iplddt, chains_ptm, pair_chains_iptm)
+ ├── affinity_[input_file1].json # The affinity scores (affinity_pred_value, affinity_probability_binary, affinity_pred_value1, affinity_probability_binary1, affinity_pred_value2, affinity_probability_binary2)
+
+ ├── pae_[input_file1]_model_0.npz # The predicted PAE score for every pair of tokens
+ ├── pde_[input_file1]_model_0.npz # The predicted PDE score for every pair of tokens
+ ├── plddt_[input_file1]_model_0.npz # The predicted pLDDT score for every token
+ ...
+ └── [input_file1]_model_[diffusion_samples-1].cif # The predicted structure in CIF format
+ ...
+ └── [input_file2]/
+ ...
+└── processed/ # Processed data used during execution
+```
+The `predictions` folder contains a unique folder for each input file. The input folders contain `diffusion_samples` predictions saved in the output_format ordered by confidence score as well as additional files containing the predictions of the confidence model and affinity model. The `processed` folder contains the processed input files that are used by the model during inference.
+
+The output confidence `.json` file contains various aggregated confidence scores for specific sample. The structure of the file is as follows:
+```yaml
+{
+ "confidence_score": 0.8367, # Aggregated score used to sort the predictions, corresponds to 0.8 * complex_plddt + 0.2 * iptm (ptm for single chains)
+ "ptm": 0.8425, # Predicted TM score for the complex
+ "iptm": 0.8225, # Predicted TM score when aggregating at the interfaces
+ "ligand_iptm": 0.0, # ipTM but only aggregating at protein-ligand interfaces
+ "protein_iptm": 0.8225, # ipTM but only aggregating at protein-protein interfaces
+ "complex_plddt": 0.8402, # Average pLDDT score for the complex
+ "complex_iplddt": 0.8241, # Average pLDDT score when upweighting interface tokens
+ "complex_pde": 0.8912, # Average PDE score for the complex
+ "complex_ipde": 5.1650, # Average PDE score when aggregating at interfaces
+ "chains_ptm": { # Predicted TM score within each chain
+ "0": 0.8533,
+ "1": 0.8330
+ },
+ "pair_chains_iptm": { # Predicted (interface) TM score between each pair of chains
+ "0": {
+ "0": 0.8533,
+ "1": 0.8090
+ },
+ "1": {
+ "0": 0.8225,
+ "1": 0.8330
+ }
+ }
+}
+```
+`confidence_score`, `ptm` and `plddt` scores (and their interface and individual chain analogues) have a range of [0, 1], where higher values indicate higher confidence. `pde` scores have a unit of angstroms, where lower values indicate higher confidence.
+
+The output affinity `.json` file is organized as follows:
+```yaml
+{
+ "affinity_pred_value": 0.8367, # Predicted binding affinity from the ensemble model
+ "affinity_probability_binary": 0.8425, # Predicted binding likelihood from the ensemble model
+ "affinity_pred_value1": 0.8225, # Predicted binding affinity from the first model of the ensemble
+ "affinity_probability_binary1": 0.0, # Predicted binding likelihood from the first model in the ensemble
+ "affinity_pred_value2": 0.8225, # Predicted binding affinity from the second model of the ensemble
+ "affinity_probability_binary2": 0.8402, # Predicted binding likelihood from the second model in the ensemble
+}
+```
+
+There are two main predictions in the affinity output: `affinity_pred_value` and `affinity_probability_binary`. They are trained on largely different datasets, with different supervisions, and should be used in different contexts.
+
+The `affinity_probability_binary` field should be used to detect binders from decoys, for example in a hit-discovery stage. It's value ranges from 0 to 1 and represents the predicted probability that the ligand is a binder.
+
+The `affinity_pred_value` aims to measure the specific affinity of different binders and how this changes with small modifications of the molecule. This should be used in ligand optimization stages such as hit-to-lead and lead-optimization. It reports a binding affinity value as `log(IC50)`, derived from an `IC50` measured in `μM`. Lower values indicate stronger predicted binding, for instance:
+- IC50 of $10^{-9}$ M $\longrightarrow$ our model outputs $-3$ (strong binder)
+- IC50 of $10^{-6}$ M $\longrightarrow$ our model outputs $0$ (moderate binder)
+- IC50 of $10^{-4}$ M $\longrightarrow$ our model outputs $2$ (weak binder / decoy)
+
+You can convert the model's output to pIC50 in `kcal/mol` by using `y --> (6 - y) * 1.364` where `y` is the model's prediction.
+
+
+## Authentication to MSA Server
+
+When using the `--use_msa_server` option with a server that requires authentication, you can provide credentials in one of two ways:
+
+### 1. Basic Authentication
+
+- Use the CLI options `--msa_server_username` and `--msa_server_password`.
+- Or, set the environment variables:
+ - `BOLTZ_MSA_USERNAME` (for the username)
+ - `BOLTZ_MSA_PASSWORD` (for the password, recommended for security)
+
+**Example:**
+```bash
+export BOLTZ_MSA_USERNAME=myuser
+export BOLTZ_MSA_PASSWORD=mypassword
+boltz predict ... --use_msa_server
+```
+Or:
+```bash
+boltz predict ... --use_msa_server --msa_server_username myuser --msa_server_password mypassword
+```
+
+### 2. API Key Authentication
+
+- Use the CLI options `--api_key_header` (default: `X-API-Key`) and `--api_key_value` to specify the header and value for API key authentication.
+- Or, set the API key value via the environment variable `MSA_API_KEY_VALUE` (recommended for security).
+
+**Example using CLI:**
+```bash
+boltz predict ... --use_msa_server --api_key_header X-API-Key --api_key_value
+```
+
+**Example using environment variable:**
+```bash
+export MSA_API_KEY_VALUE=
+boltz predict ... --use_msa_server --api_key_header X-API-Key
+```
+If both the CLI option and environment variable are set, the CLI option takes precedence.
+
+> If your server expects a different header, set `--api_key_header` accordingly (e.g., `--api_key_header X-Gravitee-Api-Key`).
+
+---
+
+**Note:**
+Only one authentication method (basic or API key) can be used at a time. If both are provided, the program will raise an error.
+
+
+## Troubleshooting
+
+ - When running on old NVIDIA GPUs, you may encounter an error related to the `cuequivariance` library. In this case, you should run the model with the `--no_kernels` flag, which will disable the use of the `cuequivariance` library and allow the model to run without it. This may result in slightly lower performance, but it will allow you to run the model on older hardware.
diff --git a/forks/boltz/docs/training.md b/forks/boltz/docs/training.md
new file mode 100644
index 00000000..2f586c28
--- /dev/null
+++ b/forks/boltz/docs/training.md
@@ -0,0 +1,263 @@
+# Training
+
+⚠️ **Coming soon updated training information for Boltz-2!**
+
+## Download the pre-processed data
+
+To run training, you will need to download a few pre-processed datasets. Note that you will need ~250G of storage for all the data. If instead you want to re-run the preprocessing pipeline or processed your own raw data for training, please see the [instructions](#processing-raw-data) at the bottom of this page.
+
+- The pre-processed RCSB (i.e PDB) structures:
+```bash
+wget https://boltz1.s3.us-east-2.amazonaws.com/rcsb_processed_targets.tar
+tar -xf rcsb_processed_targets.tar
+rm rcsb_processed_targets.tar
+```
+
+- The pre-processed RCSB (i.e PDB) MSA's:
+```bash
+wget https://boltz1.s3.us-east-2.amazonaws.com/rcsb_processed_msa.tar
+tar -xf rcsb_processed_msa.tar
+rm rcsb_processed_msa.tar
+```
+
+- The pre-processed OpenFold structures:
+```bash
+wget https://boltz1.s3.us-east-2.amazonaws.com/openfold_processed_targets.tar
+tar -xf openfold_processed_targets.tar
+rm openfold_processed_targets.tar
+```
+
+- The pre-processed OpenFold MSA's:
+```bash
+wget https://boltz1.s3.us-east-2.amazonaws.com/openfold_processed_msa.tar
+tar -xf openfold_processed_msa.tar
+rm openfold_processed_msa.tar
+```
+
+- The pre-computed symmetry files for ligands:
+```bash
+wget https://boltz1.s3.us-east-2.amazonaws.com/symmetry.pkl
+```
+
+## Modify the configuration file
+
+The training script requires a configuration file to run. This file specifies the paths to the data, the output directory, and other parameters of the data, model and training process.
+
+We provide under `scripts/train/configs` a template configuration file analogous to the one we used for training the structure model (`structure.yaml`) and the confidence model (`confidence.yaml`).
+
+The following are the main parameters that you should modify in the configuration file to get the structure model to train:
+
+```yaml
+trainer:
+ devices: 1
+
+output: SET_PATH_HERE # Path to the output directory
+resume: PATH_TO_CHECKPOINT_FILE # Path to a checkpoint file to resume training from if any null otherwise
+
+data:
+ datasets:
+ - _target_: boltz.data.module.training.DatasetConfig
+ target_dir: PATH_TO_TARGETS_DIR # Path to the directory containing the processed structure files
+ msa_dir: PATH_TO_MSA_DIR # Path to the directory containing the processed MSA files
+
+ symmetries: PATH_TO_SYMMETRY_FILE # Path to the file containing molecule the symmetry information
+ max_tokens: 512 # Maximum number of tokens in the input sequence
+ max_atoms: 4608 # Maximum number of atoms in the input structure
+```
+
+`max_tokens` and `max_atoms` are the maximum number of tokens and atoms in the crop. Depending on the size of the GPUs you are using (as well as the training speed desired), you may want to adjust these values. Other recommended values are 256 and 2304, or 384 and 3456 respectively.
+
+Here is an example of how to set multiple dataset sources like the PDB and OpenFold distillation dataset that we used to train the structure model:
+
+
+```yaml
+ datasets:
+ - _target_: boltz.data.module.training.DatasetConfig
+ target_dir: PATH_TO_PDB_TARGETS_DIR
+ msa_dir: PATH_TO_PDB_MSA_DIR
+ prob: 0.5
+ sampler:
+ _target_: boltz.data.sample.cluster.ClusterSampler
+ cropper:
+ _target_: boltz.data.crop.boltz.BoltzCropper
+ min_neighborhood: 0
+ max_neighborhood: 40
+ split: ./scripts/train/assets/validation_ids.txt
+ - _target_: boltz.data.module.training.DatasetConfig
+ target_dir: PATH_TO_DISTILLATION_TARGETS_DIR
+ msa_dir: PATH_TO_DISTILLATION_MSA_DIR
+ prob: 0.5
+ sampler:
+ _target_: boltz.data.sample.cluster.ClusterSampler
+ cropper:
+ _target_: boltz.data.crop.boltz.BoltzCropper
+ min_neighborhood: 0
+ max_neighborhood: 40
+```
+
+## Run the training script
+
+Before running the full training, we recommend using the debug flag. This turns off DDP (sets single device) and sets `num_workers` to 0 so everything is in a single process, as well as disabling wandb:
+
+ python scripts/train/train.py scripts/train/configs/structure.yaml debug=1
+
+Once that seems to run okay, you can kill it and launch the training run:
+
+ python scripts/train/train.py scripts/train/configs/structure.yaml
+
+We also provide a different configuration file to train the confidence model:
+
+ python scripts/train/train.py scripts/train/configs/confidence.yaml
+
+
+## Processing raw data
+
+We have already pre-processed the training data for the PDB and the OpenFold self-distillation set. However, if you'd like to replicate the processing pipeline or processed your own data for training, you can follow the instructions below.
+
+
+#### Step 1: Go to the processing folder
+
+```bash
+cd scripts/process
+```
+
+#### Step 2: Install requirements
+
+Install the few extra requirements required for processing:
+
+```bash
+pip install -r requirements.txt
+```
+
+You must also install two external libraries: `mmseqs` and `redis`. Instructions for installation are below:
+
+- `mmseqs`: https://github.com/soedinglab/mmseqs2?tab=readme-ov-file#installation
+- `redis`: https://redis.io/docs/latest/operate/oss_and_stack/install/install-redis/
+
+#### Step 3: Preprocess the CCD dictionary
+
+
+We have already done this for you, the relevant file is here:
+```bash
+wget https://boltz1.s3.us-east-2.amazonaws.com/ccd.pkl
+```
+
+Unless you wish to do it again yourself, you can skip to the next step! If you do want to recreate the file, you can do so with the following commands:
+
+```bash
+wget https://files.wwpdb.org/pub/pdb/data/monomers/components.cif
+python ccd.py --components components.cif --outdir ./ccd
+```
+
+> Note: runs in parallel by default with as many threads as cpu cores on your machine, can be changed with `--num_processes`
+
+#### Step 4: Create sequence clusters
+
+First, you must create a fasta file containing all the polymer sequences present in your data. You can use any header format you want for the sequences, it will not be used.
+
+For the PDB, this can already be downloaded here:
+```bash
+wget https://files.rcsb.org/pub/pdb/derived_data/pdb_seqres.txt.gz
+gunzip -d pdb_seqres.txt.gz
+```
+
+> Note: for the OpenFold data, since the sequences were chosen for diversity, we do not apply any clustering.
+
+When this is done, you can run the clustering script, which assigns proteins to 40% similarity clusters and rna/dna to a cluster for each unique sequence. For ligands, each CCD code is also assigned to its own cluster.
+
+```bash
+python cluster.py --ccd ccd.pkl --sequences pdb_seqres.txt --mmseqs PATH_TO_MMSEQS_EXECUTABLE --outdir ./clustering
+```
+
+> Note: you must install mmseqs (see: https://github.com/soedinglab/mmseqs2?tab=readme-ov-file#installation)
+
+#### Step 5: Create MSA's
+
+We have already computed MSA's for all sequences in the PDB at the time of training using the ColabFold `colab_search` tool. You can setup your own local colabfold using instructions provided here: https://github.com/YoshitakaMo/localcolabfold
+
+The raw MSA's for the PDB can be found here:
+```
+wget https://boltz1.s3.us-east-2.amazonaws.com/rcsb_raw_msa.tar
+tar -xf rcsb_raw_msa.tar
+rm rcsb_raw_msa.tar
+```
+> Note: this file is 130G large, and will take another 130G to extract before you can delete the original tar archive, we make sure you have enough storage on your machine.
+
+You can also download the raw OpenFold MSA's here:
+```
+wget https://boltz1.s3.us-east-2.amazonaws.com/openfold_raw_msa.tar
+tar -xf openfold_raw_msa.tar
+rm openfold_raw_msa.tar
+```
+
+> Note: this file is 88G large, and will take another 88G to extract before you can delete the original tar archive, we make sure you have enough storage on your machine.
+
+If you wish to use your own MSA's, just ensure that their file name is the hash of the query sequence, according to the following function:
+```python
+import hashlib
+
+def hash_sequence(seq: str) -> str:
+ """Hash a sequence."""
+ return hashlib.sha256(seq.encode()).hexdigest()
+```
+
+#### Step 6: Process MSA's
+
+During MSA processing, among other things, we annotate sequences using their taxonomy ID, which is important for MSA pairing during training. This happens only on MSA sequences with headers that start with the following:
+
+```
+>UniRef100_UNIREFID
+...
+```
+
+This format is the way that MSA's are provided by colabfold. If you use a different MSA pipeline, make sure your Uniref MSA's follow the above format.
+
+Next you should download our provided taxonomy database and place it in the current folder:
+
+```bash
+wget https://boltz1.s3.us-east-2.amazonaws.com/taxonomy.rdb
+```
+
+You can now process the raw MSAs. First launch a redis server. We use redis to share the large taxonomy dictionary across workers, so MSA processing can happen in parallel without blowing up the RAM usage.
+
+```bash
+redis-server --dbfilename taxonomy.rdb --port 7777
+```
+
+Please wait a few minutes for the DB to initialize. It will print `Ready to accept connections` when ready.
+
+> Note: You must have redis installed (see: https://redis.io/docs/latest/operate/oss_and_stack/install/install-redis/)
+
+In a separate shell, run the MSA processing script:
+```bash
+python msa.py --msadir YOUR_MSA_DIR --outdir YOUR_OUTPUT_DIR --redis-port 7777
+```
+
+> Important: the script looks for `.a3m` or `.a3m.gz` files in the directory, make sure to match this extension and file format.
+
+#### Step 7: Process structures
+
+Finally, we're ready to process structural data. Here we provide two different scripts for the PDB and for the OpenFold data. In general, we recommend using the `rcsb.py` script for your own data, which is expected in `mmcif` format.
+
+You can download the full RCSB using the instructions here:
+https://www.rcsb.org/docs/programmatic-access/file-download-services
+
+
+```bash
+wget https://boltz1.s3.us-east-2.amazonaws.com/ccd.rdb
+redis-server --dbfilename ccd.rdb --port 7777
+```
+> Note: You must have redis installed (see: https://redis.io/docs/latest/operate/oss_and_stack/install/install-redis/)
+
+In a separate shell, run the processing script, make sure to use the `clustering/clustering.json` file you previously created.
+```bash
+python rcsb.py --datadir PATH_TO_MMCIF_DIR --cluster clustering/clustering.json --outdir YOUR_OUTPUT_DIR --use-assembly --max-file-size 7000000 --redis-port 7777
+```
+
+> Important: the script looks for `.cif` or `cif.gz` files in the directory, make sure to match this extension and file format.
+
+> We skip a few of the very large files, you can modify this using the `--max-file-size` flag, or by removing it.
+
+#### Step 8: Ready!
+
+You're ready to start training the model on your data, make sure to modify the config to assign the paths you created in the previous two steps. If you have any questions, don't hesitate to open an issue or reach out on our community slack channel.
diff --git a/forks/boltz/examples/affinity.yaml b/forks/boltz/examples/affinity.yaml
new file mode 100644
index 00000000..abe04d32
--- /dev/null
+++ b/forks/boltz/examples/affinity.yaml
@@ -0,0 +1,11 @@
+version: 1 # Optional, defaults to 1
+sequences:
+ - protein:
+ id: A
+ sequence: MVTPEGNVSLVDESLLVGVTDEDRAVRSAHQFYERLIGLWAPAVMEAAHELGVFAALAEAPADSGELARRLDCDARAMRVLLDALYAYDVIDRIHDTNGFRYLLSAEARECLLPGTLFSLVGKFMHDINVAWPAWRNLAEVVRHGARDTSGAESPNGIAQEDYESLVGGINFWAPPIVTTLSRKLRASGRSGDATASVLDVGCGTGLYSQLLLREFPRWTATGLDVERIATLANAQALRLGVEERFATRAGDFWRGGWGTGYDLVLFANIFHLQTPASAVRLMRHAAACLAPDGLVAVVDQIVDADREPKTPQDRFALLFAASMTNTGGGDAYTFQEYEEWFTAAGLQRIETLDTPMHRILLARRATEPSAVPEGQASENLYFQ
+ - ligand:
+ id: B
+ smiles: 'N[C@@H](Cc1ccc(O)cc1)C(=O)O'
+properties:
+ - affinity:
+ binder: B
diff --git a/forks/boltz/examples/cyclic_prot.yaml b/forks/boltz/examples/cyclic_prot.yaml
new file mode 100644
index 00000000..1a099667
--- /dev/null
+++ b/forks/boltz/examples/cyclic_prot.yaml
@@ -0,0 +1,7 @@
+version: 1 # Optional, defaults to 1
+sequences:
+ - protein:
+ id: A
+ sequence: QLEDSEVEAVAKG
+ cyclic: true
+
diff --git a/forks/boltz/examples/ligand.fasta b/forks/boltz/examples/ligand.fasta
new file mode 100644
index 00000000..ea964b7c
--- /dev/null
+++ b/forks/boltz/examples/ligand.fasta
@@ -0,0 +1,12 @@
+>A|protein|./examples/msa/seq1.a3m
+MVTPEGNVSLVDESLLVGVTDEDRAVRSAHQFYERLIGLWAPAVMEAAHELGVFAALAEAPADSGELARRLDCDARAMRVLLDALYAYDVIDRIHDTNGFRYLLSAEARECLLPGTLFSLVGKFMHDINVAWPAWRNLAEVVRHGARDTSGAESPNGIAQEDYESLVGGINFWAPPIVTTLSRKLRASGRSGDATASVLDVGCGTGLYSQLLLREFPRWTATGLDVERIATLANAQALRLGVEERFATRAGDFWRGGWGTGYDLVLFANIFHLQTPASAVRLMRHAAACLAPDGLVAVVDQIVDADREPKTPQDRFALLFAASMTNTGGGDAYTFQEYEEWFTAAGLQRIETLDTPMHRILLARRATEPSAVPEGQASENLYFQ
+>B|protein|./examples/msa/seq1.a3m
+MVTPEGNVSLVDESLLVGVTDEDRAVRSAHQFYERLIGLWAPAVMEAAHELGVFAALAEAPADSGELARRLDCDARAMRVLLDALYAYDVIDRIHDTNGFRYLLSAEARECLLPGTLFSLVGKFMHDINVAWPAWRNLAEVVRHGARDTSGAESPNGIAQEDYESLVGGINFWAPPIVTTLSRKLRASGRSGDATASVLDVGCGTGLYSQLLLREFPRWTATGLDVERIATLANAQALRLGVEERFATRAGDFWRGGWGTGYDLVLFANIFHLQTPASAVRLMRHAAACLAPDGLVAVVDQIVDADREPKTPQDRFALLFAASMTNTGGGDAYTFQEYEEWFTAAGLQRIETLDTPMHRILLARRATEPSAVPEGQASENLYFQ
+>C|ccd
+SAH
+>D|ccd
+SAH
+>E|smiles
+N[C@@H](Cc1ccc(O)cc1)C(=O)O
+>F|smiles
+N[C@@H](Cc1ccc(O)cc1)C(=O)O
\ No newline at end of file
diff --git a/forks/boltz/examples/ligand.yaml b/forks/boltz/examples/ligand.yaml
new file mode 100644
index 00000000..e41e86eb
--- /dev/null
+++ b/forks/boltz/examples/ligand.yaml
@@ -0,0 +1,12 @@
+version: 1 # Optional, defaults to 1
+sequences:
+ - protein:
+ id: [A, B]
+ sequence: MVTPEGNVSLVDESLLVGVTDEDRAVRSAHQFYERLIGLWAPAVMEAAHELGVFAALAEAPADSGELARRLDCDARAMRVLLDALYAYDVIDRIHDTNGFRYLLSAEARECLLPGTLFSLVGKFMHDINVAWPAWRNLAEVVRHGARDTSGAESPNGIAQEDYESLVGGINFWAPPIVTTLSRKLRASGRSGDATASVLDVGCGTGLYSQLLLREFPRWTATGLDVERIATLANAQALRLGVEERFATRAGDFWRGGWGTGYDLVLFANIFHLQTPASAVRLMRHAAACLAPDGLVAVVDQIVDADREPKTPQDRFALLFAASMTNTGGGDAYTFQEYEEWFTAAGLQRIETLDTPMHRILLARRATEPSAVPEGQASENLYFQ
+ msa: ./examples/msa/seq1.a3m
+ - ligand:
+ id: [C, D]
+ ccd: SAH
+ - ligand:
+ id: [E, F]
+ smiles: 'N[C@@H](Cc1ccc(O)cc1)C(=O)O'
diff --git a/forks/boltz/examples/msa/seq1.a3m b/forks/boltz/examples/msa/seq1.a3m
new file mode 100644
index 00000000..55a5dce8
--- /dev/null
+++ b/forks/boltz/examples/msa/seq1.a3m
@@ -0,0 +1,498 @@
+>101
+MVTPEGNVSLVDESLLVGVTDEDRAVRSAHQFYERLIGLWAPAVMEAAHELGVFAALAEAPADSGELARRLDCDARAMRVLLDALYAYDVIDRIHDTNGFRYLLSAEARECLLPGTLFSLVGKFMHDINVAWPAWRNLAEVVRHGARDTSGAESPNGIAQEDYESLVGGINFWAPPIVTTLSRKLRASGRSGDATASVLDVGCGTGLYSQLLLREFPRWTATGLDVERIATLANAQALRLGVEERFATRAGDFWRGGWGTGYDLVLFANIFHLQTPASAVRLMRHAAACLAPDGLVAVVDQIVDADREPKTPQDRFALLFAASMTNTGGGDAYTFQEYEEWFTAAGLQRIETLDTPMHRILLARRATEPSAVPEGQASENLYFQ
+>UniRef100_A0A0D4WTP2 338 1.00 7.965E-99 2 375 384 1 374 375
+--TPEGNVSLVDESLLVGVTDEDRAVRSAHQFYERLIGLWAPAVMEAAHELGVFAALAEAPADSGELARRLDCDARAMRVLLDALYAYDVIDRIHDTNGFRYLLSAEARECLLPGTLFSLVGKFMHDINVAWPAWRNLAEVVRHGARDTSGAESPNGIAQEDYESLVGGINFWAPPIVTTLSRKLRASGRSGDATASVLDVGCGTGLYSQLLLREFPRWTATGLDVERIATLANAQALRLGVEERFATRAGDFWRGGWGTGYDLVLFANIFHLQTPASAVRLMRHAAACLAPDGLVAVVDQIVDADREPKTPQDRFALLFAASMTNTGGGDAYTFQEYEEWFTAAGLQRIETLDTPMHRILLARRATEPSAVPEGQ--------
+>UniRef100_UPI00199CC1A7 304 0.851 3.950E-87 8 371 384 1 364 369
+--------SLVDESLLAGVTDEDRTVRSAHQFYERLIGLWAPAVMEAAHELGVFVALAEEPVGSAEMARRLDCDPRAMRVLLDALYAYDVIGRIHDTNGFRYVMSPEAQECLLPGRLFSLVGKLAHDIDVAWPAWRNLASVVRHGARDTTGTDSPNGIAEEDYESLVGGINFWAPPIVAALTRKLHALGRSGESAASILDVGCGTGLYSQLLLREFPEWTATGLDVERIAALASAQSLRLGVAERFGTGVGDFWKGDWGTGYDIVLFVNIFHLQTPASAARLMRNAAASLAPDGLVAVVDQIIDADREPKTPQDRFALLFAASMTNTGGGDTYTFQEYEEWFTAAGLQRVETLDTPMHRILLARRVTETPAA------------
+>UniRef100_UPI001674A1EF 256 0.569 1.909E-70 8 367 384 30 389 395
+--------ELVDYNYLSTTTGERKTIRAAHQLYEHLISLWAPAIIETAHDLGVFARLAKGPGTVAELATDLDTDQRATRVLLGGLVAYGVLERSDDDGESRYVLPEEFRHALLPGGTFSLVGKMAHDRHVAWAAWRNLGDAVRHGTRDRSGNDRTNQISETNYEDLTFGINFWAPPIVDVLSSFLAESGWKKDQAVSVLDVGCGTGLYSQLLLERFPSWTAEGIDAPRIIPLATRQAEKIGVGARFTGTVRDFWQHGWGEIVDLILFANIFHLQTDDSVQKLMRSAADVLAPDGLICIADQIVVDEARPTTAQDRFALLFAASMLATGGGDAYALSTYDQWLAEAGLERVAVLEAPMHRLLLVGHAGR----------------
+>UniRef100_A0A229H607 251 0.571 5.884E-69 11 369 384 1 362 363
+-----------DFNFLSATTGEQKTVRAAHQIYEHLIGLWAPAVIEAAHDLGVFSWLANRPGTVEEMSAELETDQRATRVLLGGLLAYGVIERSELDGEVRYSLPSEFRQALLPGGTFSLVGKMLHDRHVAWAGWRNLGDAVRHGTRDQSGNDRTNQISEADYEDLTSGINFWAPPIVDVLSAALAETGWKKDEAVSVLDVGCGTGLYSQLLLERFPAWKAEGIDAPRIIRLATAQAERLGVGSRFTGTVRDFWKDGWGETVDLILFANIFHLQTPDSVQKLMRSAADVLAPDGLICIADQIVVDEARPVTAQDRFAMLFAASMLATGGGDAYTLSAYDQWLAEAGLERVAVLEAPMHRLLLighAGRHPLPA--------------
+>UniRef100_A0A6I4VXR1 248 0.510 7.112E-68 19 365 384 24 367 381
+-------------------TPAARQSATAHRVYEALIAMWSTGVIEAGHDLGLFERLATGPATVPELAADLGADPRATRVLCDALVVYGVLER---GDHGRFAMPADIAACLLADGLYSLAGKIFYDRTVAWDAWRGLADAVRRGPVDAHGDDQANQISDVDYEQLTGGINFWAPPIAELLAGWLRDAGWDARPGRTVLDVGCGTGIYSHLLLQAFPGATSTGLEAARIVPIADRQAGLLGVADRFTATACDFMSDPWPSGVDLALFVNIFHLQHPAAARRLLARSAAALAPDGVLCVVDHIVDREGPLDSPQDRFALLFAASMLATGGGGAHALADYDLWLAGAGLRRVALLDAPMHRVLFAARA------------------
+>UniRef100_UPI001678806F 245 0.509 6.291E-67 8 363 384 2 358 361
+--------RLVDSTKLIGDPRDSAVVRASHRVYEHLVAMFAPGLIEAAFDLGAFVALADGPAGAAELAERLDADPLGVRVLLDGLSCYEIVYRESAPEGGhRYRLADGMAECLLPGGLYSLAGRIRYDRAIGWDAWRDLAQHVRHPARDDSGAYRANQLSAEDYESVARGINFWAPPIVEALAGLLTDTGWKEETPRSMLDVGCGTGIYSQLLLQRFKELTATGLDDPRIVPIAEEQAQRLNVGARFSPVSQDFFQQPWPGGQDLVLLVNIFHLQTADGAQELMHRARQAVREDGVVAIVDHIVDDDSEPHSPHNRFFRLFSASMLVTGGGDSFSLAEYDQWLERAGLCRTALVDTPMHRILLAR--------------------
+>UniRef100_UPI0021B13CE5 245 0.569 6.291E-67 8 367 384 30 389 395
+--------SLVDYNYLSATTGERKTIRAAHQLYEHLISLWAPAIIETAHDLGVFAWLAERSGTAEQLADGLKTDRRATRVLLDGLFAYGVLERSAAGGEVRYTLPEDFRHALLPGGTFSLVGKMAHDRHVAWAAWNNLGDAVRHGTRDQSGNDRTNQISETDYEDLTSGINFWAPPIVDVLASYLAESGWKQNETASVLDVGCGTGLYSQLLLERFPSWTAEGIDAPRIIRLADRQAERLGVADRFTGTVRDFWQHGWGEIVDLILFANIFHLQTADSVQKLMRSAADVLAADGLICIADQIVVDEAHPTTAQDRFALLFAASMLATGGGDAYALSEYDQWLAEAGLERVAVLEAPMHRLLLVGHAGR----------------
+>UniRef100_A0A640S974 244 0.654 1.173E-66 9 364 384 6 359 361
+---------LVDTSLLPSATHEEKVIRTAHAFYEHLIGLWAPAIIEAAHETGIFAALADRPVTADDLAASLHADPRTTRVLLDALYAYDVIDRIRSTDSFLYVLSDAARECLLPGGVFSIAGKMVHDRRVAWSAWANLGEVVRQGTR--TGTENDNQISERDYESLVGGINFWAPPIVDVLTDELRRRGADGGTPATVLDVGCGTGLYSQLLLRAFPAWCAMGLDAERIAPLAAAQGQRLGVADRFLVRSGDFWTEDWGTGHDHLLFANIFHLLTPASGQRLMDLAARSVSATGTVVVIDQILDAEREAKTPQDRFALLFAASMANTGGGDAYTFQDYDDWFAGAGMKRVATLDAPMHRILLAQR-------------------
+>UniRef100_F2YRZ2 244 0.563 2.186E-66 27 362 384 2 338 342
+---------------------------SAHRIYEHLISLWAPGVIEAAHDLGVFAELSSGPRTSDQLAESCDSNQRAMRVLLDGLFAYDILDRIPsDSGPTVYRMPDEMRECLLPGGLFSLVGKIEYDRQLAWHSWRNLADAVRTDNRDASGDLQLNQITEHNYESLVRGINFWAPPIVAALADGFETFEWPTDRPASVLDIGCGTGLYSQLLLERFPKWRATGLEAPHIAPIAEAQAQRLGVADRFDVQVRDFWTESWGSDHDLLIFVNIFHLQTPESSLELLRKSKESLADGGLICIADHMVTDEQEAKPVQDRFAMLFAASMLATGGGDAFLLDEYDTWLAEAGLRRVAVLDTPMHRILLA---------------------
+>UniRef100_UPI000A38C1E5 242 0.540 7.592E-66 9 364 384 17 370 371
+---------LVDTSLLPADDDGARAT---HRVYEHLIGMWAPGVIEAAQDLGVFATLTDGPATAAGLAETLGTDLRATRVLLDGLHAYDIVGRERGGDGqAVYTLPASLRGVFAPDGLYSLAGKITHDRNVAWQAWRHLADNVRGGARGEHGGQQVNQISEEDYTSLARGINFWAPPVVSVLADALRERGWGDDTEAVLLDVGCGTGIYSHLLLQAFPQLTARGLDAPRITAIAAEQAERLGVSERFSPLTADFWNDDWGNGTDLALFVNIFHLQTPESAHELLLKTAKGLGEGGLIAIVDHIVDEEAGSGNVQNRFFRLFAASMLATGGGDAYTVHDYDQWLADAGLRRVALLDTPMHRVLLAGR-------------------
+>UniRef100_A0A7C3EEX2 241 0.311 1.415E-65 21 365 384 281 612 615
+---------------------EGRAAADAGRLMELAWGYAAPVVIATAVRYGLFGSIGHRGASIEELVRRTGLSERGLRILLQALVGLRLLRR----NGSRFELTPESATCLVPEQPEYRGGLFLHHVEHLLPRWLQLPEVVRTGWPVREPQCPA-----HRYAGFVESLFASNYPAAKALQRHLQLAGRK--EPFQVLDLGAGSGVWGIALAEGAPQVWVTAVDWPEVLLIARKKAAAYGVSDRFRWVEGSFFEVPLGRGYDLVVLGHVLHAEGVEGVRTLLRRSCDALRPGGLVAIQEFLPDDDRSGP----LLPLLFAVNMLVnTEAGDTYTLAELTGWLEEAGFEAVETLNVPaPSPMVLARKP------------------
+>UniRef100_UPI00167C15C9 241 0.504 1.931E-65 9 365 384 30 388 389
+---------LVDGSKLIGDPRDSAVVRASHRVYEHLIAMFAPGMIEAAFDLGVFVALADGPATPTDLAARLDADAHGLRVLLDGLYCYEIVQRVRAEDGEdLYRLVDGMAECLLPGGLYSLAGRIGYDRAIGWDVWRNLADHVKRPARGADGGYQANQLSAEDYEQVARGINFWAPPIVESLANLLaEEEGWKGEADRSMLDVGCGTGIYSQLLLQRFRGLRATGLDHPRIVPIARGQAERLGVRERFEPVERDFFTEEWNTGQDLVLLVNIFHLQTAEGSEELMRRAAQAVRQGGVVAIVDHIVDDETDDQSIQNRFFRLFAASMLVTGGGDSFSLADYDQWLDRAGLVRTALVDTPMHRILLARRP------------------
+>UniRef100_UPI001BA9CE47 241 0.559 2.636E-65 5 364 384 20 382 384
+-----GNVQpLVDTALLPAGDGQPRVVRAAHRLYEHLISLWAPGAIEAAFDLGVFDELAKGPATADELAKSLSTNAKATRVLLDGLNAYDLLVRTWDADGtVVYVLPDEVRDVLRPDGLFSLAGKIGYDRQMAWGAWRNLAETVRTGALADDGSQQHNQISASEYESLVRGINFWAPPVVHALSAQLKEHGWAGDKTAGMLDVGCGTGIYSQLLLQQFAGLTATGLDVERILPLAIAQSEQLDVADRFHPLRRDFWREDWGTGFDLVLFVNIFHLQTPEDARDLAIKANKALADGGLVAIVDqIVVEDEVQQNSTQNRFFRLFAASMMATGGGDAYTLDQYDEWLTGAGLRRVALIDTPMHRILLAGR-------------------
+>UniRef100_A0A1V2QL50 239 0.561 6.705E-65 9 365 384 18 375 376
+---------LVDTALLPGHGLQHDVVTAAHRVYEHLIAIWAPGVIEAAHDLGVFVELSAGPATAERLAERLDTEPRATRVLMDALYAYDIVERTTEaSAPPSYRLPAAMRECLLPGGMFSLVGKIAYDRRLAWRAWQDFAGAVRRGSRDGSGSDQLNQISVDEYESLVSGINFWAPPVVQVLRQGLRDLAWPCDRAVRMVDVGCGTGLYGQLLLREFPQWTAVGLDVARIAPLATSQAAELGVAARFEATVCDFWQDSWGQDVDLILLANIFHLQTPESAETLVRLAAEALAEDGMLCIVDHVVDDERTAKSAQDRFALLFAASMLATGGGDAYTLKDYDDWFVRYGLRRERILETPMHRILLVTRA------------------
+>UniRef100_A0A2M9IGJ8 239 0.552 6.705E-65 3 362 384 18 379 383
+---PELNVRpLVDTTLLPDWRGSGRVVHSAHRVYEHLISLWAPGVIEAAHDLGVFAELSAGPRTSDQLARACAANQRAMRVLMDGLYAYDIVDRVPTEDGpAVYRMPEEMRECLLPDGLFSLVGKIEYDRQLAWHSWRNLADAVRGDNRDETGGLQLNQISEHNYESLVRGINFWAPPIVEALRGGFETLEWPTDRPASVLDIGCGTGLYSQLLLRAFPRWRATGLEAPAIAPIATAQAERLGVADRFGVQVRDFWTESWGTGHDLLVFVNIFHLQTPESAQELLRKSKEALSRDGLICIADHLVTDEKDAKSVQDRFAMLFAASMLATGGGDAFLLDDYDQWLASTGLRRVAVLDTPMHRILLA---------------------
+>UniRef100_A0A0B5DK60 238 0.563 1.705E-64 27 362 384 43 379 383
+---------------------------SAHRIYEHLISLWAPGVIEAAHDLGVFAELSTGPKTSDQLATACDAEQRAMRVLMDGLYAYDIVDRIPaDAGPALYRMSEEMHECLLPGGLFSLVGKIEYDRQLAWHSWRNLADAVRRDNRDETGSLQLNQITEHNYESLVRGINFWAPPIVEALRGGFETLEWPTDRPASVLDIGCGTGLYSQLLLRAFPGWRATGLEAPNIAPIARAQAERLGVADRFDVQVRDFWTESWGSDHDLLVFVNIFHLQTPESAQELLRRSKEALSKDGLVCIADHLVTDEKDAKSIQDRFAMLFAASMLATGGGDAFLLDDYDRWLASAGLRRVAVLDTPMHRILLA---------------------
+>UniRef100_UPI00055F6ABE 235 0.547 2.803E-63 9 365 384 14 368 369
+---------LVDTELLPSPTGE---IRAAHRLYEHLIGMWATGVIEAAQDLGAFAALTVAPATASGLSELLGTDLRATRVLLDGLYAYDVVERSRGADGqAVYTLPAELHQVFAPDGLYSLAGKIGHDRNVAWHAWRNLADAVRSGARGEDGAQQLNQISESDYTSLVRGINFWAPPITSALADGLRELGWTDGEAATLLDVGCGTGIYSHLLLDEFPGLQARGLDAERIIPIATEQAARLGVADRFDPVVCDFWNDDWGTGVDLALFVNIFHLQTPESARELLLKSAKSLSEDGVIAIADHIVDEDGGVGSTQNRFFRLFAASMLATGGGDSFTVQDYDQWLADAGLRRVALIDTPMHRVLLARRA------------------
+>UniRef100_A0A3E0GTP3 234 0.521 3.825E-63 9 364 384 6 362 364
+---------LVDTGLLPADGANSDVVMAAHRVYEHLIALWAPGVIEAAHDLGVFDALGTAPARADELAEQLGTDTKATGVLLEALYAYEIVAREVADDGvVGYTLAPAMAEVLSPTGLFSLTGKIGYDRKLAWDAWRGLADAVRSGRYDASGSEQGNRISEYEYESLVTGINFWAPPIVRELGRALRELGWPTTESARMLDIGCGSGLYSHLLLQEFPGLSAVGIDVELILKIAVEQSLRLGVADRFATFDGDFTSDDLGRDFDLVLLVNIFHLQSGDSAGLLAKRVASALGDNGIVAIVDQIIDDRQGPRSTHNRFFRLFATSMLATGGGGAYTVDDYDAWLESAGLHRIALVDTPMHRVLLAKR-------------------
+>UniRef100_A0A918C4G1 234 0.536 3.825E-63 25 364 384 30 370 371
+-------------------------ARATHRVYEHLIGMWAPGVIEAAQDLGVFATLTAGPATAAGLAETLGTDLRATRVLLDGLHAYDIVQRERGGDGqAVYTLPASLHGVFAPDGLFSLAGKITHDRNVAWHAWRHLADNVRSGARSAHGGQQVNQISEEDYTALARGINFWAPPVVSVLADALRERGWGDETDALLLDVGCGTGIYSHLMLEAFPRLTARGLDAPRITAIASEQAARLGVHDRFEPLTADFWNDDWGNGTDLALFVNIFHLQTPESAHELLLKTAKGLTEGGLIAIVDHIVDEEAGGANVQNRFFRLFAASMLATGGGDAYTVQDYDQWLADAGLRRVALLDTPMHRVLLAGR-------------------
+>UniRef100_UPI0018D5B757 233 0.517 9.722E-63 9 371 384 14 375 376
+---------LVDTAALADL--DDAESRAHHHLYEHLIGLWAPGLIEACHDLGIFTALRRGPASATDVADAVGADPRAVRVLLDGLQAYGIVRRAESGDPhPVYLLPAELHQAFSSDGLYSLAGKISHDRGIAWDAWRRLADRARTDTRSDGAPPRPNQISEDDYTALVRGINFWAPPIVHRLAGALRESGWAARTAPTLLDVGCGTGIYSHLLLREFPELTAHGLDAERIIPIAERQAARLGLaPSRFRGRTGDFWNDDWGSGYDLVLFVNIFHLQTPELACALLAKAAGSLAADGVIAIADHIVD-DAEPDSPQNRFSRLFAVSMLATGGGDAFTVQEYDRWLASARLRRFRLVNTPMHRVLLARRAAGPAAA------------
+>UniRef100_A0A6G4X3C8 233 0.555 1.327E-62 22 362 384 31 372 376
+----------------------DGEVRAAHRLYEHLIGIWAPGVIEAAQDLGAFAALTEGPATAAALAETLGTDLRATRVLLDGLSAYDVVQRTRGADGqAVYTLPAELHGVFAPDGLYSLAGKIGHDRNVAWSAWRNLARNVRDGARTSDGAEQLNQISEEDYTSLVRGINFWAPPIVRPLAERLRTTGWGTGSGRTLLDVGCGTGIYSHLLLKEFPELSATGLDVGRIVPIAEAQAAQLGVADRFRCVTGDFWNDEWTGDTDLALFVNIFHLQTPESARDLLLKSAKALSDDGVIAIADHIVDEEEGEDSTQNRFFRLFAASMLATGGGDAFTVHDYDQWLSDAGLRRVGLLDTPMHRVLLA---------------------
+>UniRef100_UPI001CD37CE1 233 0.541 1.327E-62 3 362 384 18 379 383
+---PELNVRpLVDTTLLPDWRGAGKVVHSAHRVYEHLISLWAPGVIEAAHDLGVFAELSTGPKTGDQLARACAANPRAMRVLMDGLYAYDVVDRVPaEDGPAVYRMPEEMRECLLPDGLFSLVGKIEYDRQLAWHSWRNLADSVRGDNRDEAGRLQLNQITEHNYESLVRGINFWAPPIVEALRGGFETLEWPTDRPASVLDIGCGTGLYSQLLLRAFQQWRATGLEAPSIAPIAMAQAERLGVADRFDVQVRDFWTESWGSDHDLLVFVNIFHLQTPESAQELLRKSKEALSRDGLVCIADHLVTDEKDAKSVQDRFAMLFAASMLATGGGDAFLLNDYDQWLASAGLRRVAVLDTPMHRILLA---------------------
+>UniRef100_A0A2T7T4I2 233 0.530 1.327E-62 3 362 384 18 379 383
+---PEHNIRpLVDTALLSDWRGSGKVVHSAHRIYEHLISLWAPGAIEAAHDLGVFAKLSTGPMTGDQLAEACQANRRAMRVLMDGLYAYDIVDRSSTDDGpAVYRMPEEMRECLLPDGLFSLVGKIEYDRQLAWPAWRNLADAVRHDNRDEVGELQLNQINEHNYASLVRGINFWAPPVVEALRGGFETLDWPTDRPASVLDVGCGTGLYSQLLLRHFGQWRATGLEAPHIASIAEEQAERLGVAERFEVQVRDFWTESWGSGHDLLLFVNIFHLQTPESARELLHKSKQALSENGMICIADHLVTGEQDAKSIQDRFAMLFAVSMLATGGGDAFLVDEYDGWLAETGLRRLALLDTPMHRILLA---------------------
+>UniRef100_UPI001661D816 232 0.548 2.471E-62 2 361 384 7 364 369
+--TFDNHTPLVDTELLPG---RGSGVNAAHRMYEHLIGIWATGVIEAAHDLGAFTALIGAPATAGELSTRLGTDLRATRVLLDGLAAYDVVERSRAADGqAVYTLPPEMHDIFAPEGLYSLVGKIRHDRNVAWGAWRNLAGNVRTGARNSEGSQQLNQISEEDYTSLVRGINFWAPPIAATLATALREQGWTDGAGRTLLDVGCGTGIYSQLLLQEFSGLNARALDAERIIPIANAQAHRLGVAERFNPEVVDFWADDWGTGVDVALFVNIFHLQTPESARELLLRSAKALTEDGVIAIADHIVDEDSTDGNTQNRFFRLFAASMLATGGGDAFTVQDYDQWLADAGLRRVALLDTPMHRLLL----------------------
+>UniRef100_A0A7V1RGG8 231 0.309 3.371E-62 23 366 384 3 336 340
+-----------------------ELAPDPTALFELATGFWASATLLAAEEVGVFHVLTEAPRTASEAAQALGADRRALERLLDACSGLNLLVK----QGERYLLSPLAAAYLVPGAPGGLASG-IAWARDQYAAWGRLAETVRTGRPAVDPGDHLGG-DPEQARRFVLAMHERAAGIARAVVGSL-----NLDGVERLLDVGAGPGTYAVLLARRHPGLSATLLDLPPILDAARELVDACGVAERIALRPGDASSGQYgEEAFDAVLFSGVLHQMPPETIRRMLEGAFRALVPGGRVFLSDILADATHTRPV----FSALFSLQMLLTTeGGGVFSVEECRSWLEQAGFAEIEVQRLPaplPYTVVSALRPR-----------------
+>UniRef100_D7BZK8 231 0.566 6.277E-62 22 364 384 25 368 370
+----------------------DGEVRAAHRLYEHLIGIWAPGVIEAAQDLGAFAALTVGPATAAQLAEVLDTDLRATRVLLDGLYAYDVVERSRGEDGqAVYTLPAELHGVFAPDGLFSLAGKIGHDRNVAWNAWRRLAENVRSGARTAEGAQQLNQISEEDYTSLVRGINFWAPPITRSLAGALRELGWTTGRSRTLLDVGCGTGIYSHLLLREFPELTARGLDAERIIPIAARQAGQLGVAERFQGEVVDFWSEDWGSGTDLALFVNIFHLQTPESARELLLKAVKGLTEDGVIAIADHIVDEDGGEGSVQNKFFRLFAASMLATGGGDAFTVHDYDQWLADAGLRRIGLLDTPMHRVLLARR-------------------
+>UniRef100_A0A1R1S6N2 231 0.569 6.277E-62 22 364 384 25 368 370
+----------------------DGEVRAAHRLYEHLIGMWAPGVIEAAQDLGAFAALAVGPATAAQLAEILDTDLRATRVLLDGLYAYDVVQRtRGDDGQAVYTLPAELHGVFAPHGLFSLAGKIGHDRNVAWNAWRHLADNVRSGARAADGAQQLNQISEEDYTSLVRGINFWAPPITRALAGALRDLGWTTGRSANLLDVGCGTGIYSHLLLREFPELTARGLDAERIIPIAARQATQLGVAERFRGEVVDFWSEDWGSGTDLALFVNIFHLQTPESARELLLKATKGLTEDGVIAIADHIVDEDRGEGSVQNKFFRLFAASMLATGGGDAFTVHDYDQWLADAGLRRVGLLDTPMHRVLLARR-------------------
+>UniRef100_UPI00224D4A51 229 0.538 1.595E-61 9 362 384 17 369 381
+---------LVDYTKLSADGAAPSEIRAAHQVYEHLVSLWAPSIIEAAHDLGFFVELADGARTADEVAHARGTDRRATRVMLDALYAYGLVGKSCEGSvPHRYVLPDACRGALLPGGFFSLVGKMAHDRNVAWNAWSDLARTVRRGTCDESGEDLANGISETDYEDLVTGINFWAPPIVDTLANCLADSGWKAGEAVSVLDVGCGTGLYGQLLLQRFPQWRAEGIDAPRIVPLADAQAKRLGVEDRFTGTVQDIWRGGWGEGADLILLNNMIHLQTAESGRKLLRTAADSLAPDGLVCIADQVIVNDEES--PQDRFAMLFAASMLATGGGDAHSLDTCKEWFAAAGLEMVAVLDAPMHRVVIA---------------------
+>UniRef100_UPI0020BDB3A6 228 0.555 4.051E-61 9 365 384 17 371 372
+---------LVDTARLTGVEAESQA---AHHLYEHLIGLWAPGVIEAAQDLGAFSALTLGPATAVRLAEILGTDLRATRVLMDGLHAYDVVRRSHSADGqALYTLPPELHDVFSPHGLYSLVGKISHDRKLAWNAWRNLAENVRTGARDATGGERVNQISEEDYTSLVRGINFWAPPIVRTLADALRELGWTTGESARVLDVGCGTGIYSQLLLREFPALTASGLDTERITAIASRQAQELDVADRFEVVVKDFWNDDWGTDIELALFVNIFHLQTPESARELLLKSSKSLAQGGLVAIADHIVDDDDGAGSVQNKFSRLFAASMLATGGGDAYTLHDYDQWLADSELRRVALLDTPMHRVLLARRA------------------
+>UniRef100_A0A5D0QPB3 228 0.563 7.541E-61 9 362 384 7 358 362
+---------LVDRRLLPDVGAGHETVAAAHHVYEHLIALWAPGAIEAAFDLGVFAALADGPATAEALAGRLEVDQRGMRVLLDALSAYDLIDRGSSAGGVRYGLRAGLRECLLPDGLYSLAGKVRYDRMLAWTAWRNLAQAVRGDGSAVP---QHNQISTTEYESLVRGINFWAPPIVSILAGALRDRgWPAGPAAPAMLDVGCGTGLYSQLLLQQFPELTGVGFDVERIVSIARAQSERMDVGDRFQPLAIDFWQRDWGTGFDLVLFANIFHLQTPDSARELSIRASKALAGGGVVAIIDQIVDDRADADSVQDRFFRLFAASMLATGGGDAYPLSDYDEWLSVAGLRRAALVDTPMHRILLA---------------------
+>UniRef100_A0A1E7JVS4 227 0.558 1.404E-60 22 362 384 25 365 369
+----------------------DGEVRAAHRLYEHLVGIWAPGVVEAAQDLGAFAALTEGPATAAQLSERLGTDLRATRVLLDGLHAYDVLGRARGEDGqPVYSLPPEMHGVFAPGGLYSLAGKITHDRNVAWDAWRNLAENVRSGARTSGGAQQLNQISEEDYTALVRGINFWAPPITQVLAEGLRAHGWTSGADRRMIDVGCGTGIYSQLLLNEFPELRARGLDVERIVPIAQEQAKRLGVADRFRTEICDFWNDDWGNDSSLALFVNIFHLQTPESAHELLLKTSKSLAEDGVIAIADHIVDEDEDGST-QNKFSRLFAASMLATGGGDAFTVQDYDQWLADAGLRRIALLDAPMHRVLLA---------------------
+>UniRef100_UPI0018F88670 224 0.498 1.684E-59 22 364 384 12 356 364
+----------------------DAASRRAHLLYEQLVSLWTPAVIEAAHDVGLFSALSRGPATSDELAAALSVHPRGARILLDALFACDLVECDEQPGcAPIYTLPEDVKACVEPLGLFSLAGKMLYDRRFAWDAWRNFATAVREGGVdQSSKQCRQNQISPEEYRFLTRGINFFAPPIIHALGEGLAKIGWSTRRAISVLDVGCGTGIYSQLLLQRHATWRAVGMDCETMAALARAQSAELGVEDRFSCRASDLWRLPWGGDFDLILLCNMFHLQSPDGAARLMKLAGEAVSTAGIVCVIDQIRDEHRHVDTAQNRFALMFAASMLATGGGDTYTLEQYDEWLRDAGLERLIVLPAPMHRILIARR-------------------
+>UniRef100_I2Q4T4 223 0.314 3.133E-59 27 353 384 5 316 332
+---------------------------TPAALLEIAGGYWKTCALHAGVVLDVFTPLADVPLTAGELAARLGCDARALGMLLRALAAMELLSR----SGERYALTGEAREFLDARSPRYIGYAVRHH-HRLMPVWTRLPEAIRSGRSLREHM--GGDADPGDREDFLLGMFNIAMGVAPRLARTLDLSGR-----RRLLDLGGGPGTYAVHFCLAHPDMTATVFDLAGSREFAASVSERFGVADRVEFVAGDYLRDPVPGGYDVAWLSQILHAEDPAGCRTILGKAAGALSPGGLLFVHEFMLDDDAAGP----EFAALFSLNMlLGTDHGQSYPEGRIREMMEGAGLKNVRRLD------------------------------
+>UniRef100_A0A840IMV4 222 0.583 4.274E-59 44 362 384 1 314 318
+--------------------------------------------IEAAHDLGVFVELAGEPRSGAELARALDADPRAMSVLLDALCAYDLL---VEDGNARYALPAELRECLLPDGLFSLVGKIEYDRTLAWRAWRNLADTVRAGTRVEDGSDAPNQIGETEYRSLVHGINFWAPPIVNVLAGALAERGWTPRRPVSLVDVGCGSGIYSHLLLRRFPALTATGIDVRRIMPLALAQADRLGVADRFRPAVMDFWSEDWGLGYDLALFVNIFHLQTPASAEELLRRAAKSLAGGGLVAVVDQIVTGDAHS--AQNRFSRLFAASMLATGGGGAYRTEDYDRWLDGAGLTRVALLDTPMHRVLLA---------------------
+>UniRef100_UPI00210A57ED 218 0.529 9.522E-58 10 365 384 40 405 406
+----------VDRSRLAGT---DAQSSAAHRVYEHLVALWAPGVIEAAQDLGAFAALTSGPATAAELARTLDTDPRATRVLLDGLHAYDIVERAMTEDGEiRYTLPVELHDVFSPGGLYSLAGKINYDRSLAWNAWRDLAHNVRTGARDAEGGHQLNQISEEEYTSLVRGINFWAPPIVSALADALREQGWSTGDGAKVLDVGCGTGIYSQLLLREFPLLTARGLDVARITPIAIRQAKELGVADRFEPTVVDFFHDSWGGG-DLALFVNIFHLQTAESARELMLKAAKEINEDGVIAIADHIVVEDTHGAPgvsdgadaagtgsVQNRFFRLFAASMLATGGGDAYTVEEYDGWLADAGLRRIALIDTPMHRLLLAKRA------------------
+>UniRef100_A0A3C0VCK0 218 0.279 1.299E-57 33 364 384 9 323 326
+---------------------------------QMASGFMPARVLLTALELDVFTACGAGAATAEELARRTGARPAPLARLLNALAALGLLDKRGD----RYRATPPARTHLIAGRPGYL-GDIMRHRASMWERWSDLTAIVRTGR------VPPRAFTKERERRFIKGMANLGASAAPACARALR---RELAGARRLLDIGGGPAVYACELARAWPKLSVVVLDLPGPLAYARETIAAYGLARRVSVKAGDVCAArSFGRGFDVAFMSSLIHSFKPAVVAEVIRKAAGALRPGGFLAVKEFFIDPGRASPP----FTALFSINMLVAGAGDVYTRGEVEGWMRAAGVRPVRYVDLPQFSGIVVGR-------------------
+>UniRef100_A0A1F5AWX5 218 0.297 1.299E-57 28 365 384 2 329 330
+----------------------------PTRLVEMASAFYESSVLFAASDLGIFAKLAElGEADARTISAVSRLDPRGARLLLDACVALELLVKKGD----RYQNSPEAAAFLVPGAPADLSGAIRYNRD-VYGAWGKLKELVKTGKP-VERAELHLGEDPERTRTFVLAMHGRAMGIGQAVIPLLDLDGRKA-----VLDVGGGPGTYSILIARAFQQVRCTVIDLPEVARIADEIISQAGVGNRVRTLAGDYHTLPFPADQDTVVFFGVLHQEDPAAIQDLFRRAYGAMLPGGRIYVLDMMTDASH----ARPKFSALFGLNMaLTTPHGWVFSDDELKGWLKEAGLTDFNCRPLPppmPHWLATARKA------------------
+>UniRef100_G7Q8Y2 218 0.307 1.299E-57 27 353 384 5 316 332
+---------------------------TPAALLEIAGGYWKTCALHAGVVLDVFTPLGDGPLTAGELAVRLGCDARALGMLLRALAAMELLAR----SGEGYALAGEAREFLDARSPRYIGYAVRHH-HRLMPVWTRLPEAIRSGRSLREHM--GGDADPGDREDFLMGMYNIALSIAPRLAQSLDLSGR-----RRLLDLGGGPGTYAVHFCLAHPEMTATVFDLAGSREFAASVSERFGVADRVEFVAGDYLKDPVPGGHDVAWLSQILHAEDPAGCRTILGKAAGALSPGGLLFVHEFMLDDDAAGP----EFAALFSLNMlLGTDHGQSYPEGQIREMMEAAGLRDIRRLD------------------------------
+>UniRef100_A0A3C1EP29 216 0.289 6.124E-57 28 361 384 10 327 336
+----------------------------AAPIMALARGFMASRILLTAFDLDIFTALDRGPIDSVQAARRIRCDNRATDRLLNALVSLGLTRK----KGRLFSNTPLAARHLVRGRPEYLAG--LGHCVHLWDSWSTLTAAVRRGRSVLEPSVGRRGAAW--LSAFISAMHERARAQADAVVK-----GLDLGAVESVLDVGGGSGAYAMAFVRAKPGLRATVFDLPQVAPLTRRYISREGLSGRVAVRAGDYEKDPLPKGFELVLLSAIIHSNSPTANIRLLRKCRRSLNPGGRIVIQDFVMNPDRTAP----AFGAIFALNMLtATAAGDTYTESEIRSWLKQAGFGSIKRRDTPFASTLI----------------------
+>UniRef100_A0A933TFS2 216 0.306 8.351E-57 38 364 384 23 334 335
+--------------------------------------FMESRVLLTAWELGVFTALGRGARTAAQVARTARADPRAMDRLLDALVSVGLARK----SGRIFSNSPSAARYLVAGRPAYIGS--LGHMASLWESWSTLTQAVRAGRSVLKDDMPRRG--KEFFVPFIAAMHERSSLQGPSFARALP-----LAGVRRLLDVGGGSGAYSIAFARAHPALRATVFDLPQVVPLARGYIRAAGLQDRVEARVGDYDRNPLPDGYDLVFLSHILHSNSPARNRRLLRKCARSLNPGGLVVIQEFLVDEDRTGP----QFAALFALNMLVgTPAGDAYTEREIGSWLKGARLRGIRRKDTAFDSaLLIARR-------------------
+>UniRef100_A0A7V5CKK2 215 0.283 1.553E-56 27 356 384 3 316 329
+---------------------------SVDKVWETARAFQASRILLTGFELGVFATLGDNAMTSAEVASKIGADPRAADRLMDALVVLGLLTK----EEGKFRNSGEARETLVPGKPTYAGGALGHVIS-LWKSWSTLTDAVRKGTSVFKHEDEARA---EFVKPFIAAMHFNASNLAPIILKQI-----DLTGVRRVLDVGGGSGAYSIAFCKASPEITSVIFDLPDVVPLTNEYAAKAGVADRISTVTGDFNTDNLPVGFDLAFLSQILHSNSPDENERLMRKVGTALNPGGQIVVQEFVVDEDRISPPG----PVFFSLNMLVgTKAGDTYTEKEIGSWLDGAGFGEIKRIDPPG---------------------------
+>UniRef100_A0A1V4XPT3 214 0.272 2.117E-56 27 352 384 4 314 331
+---------------------------TPEAVLQLARQFMESRILLTAAELGLFSPLAKKPHTAEQLSGRLGCDTRALAILLDALAAMGLLEK----RDGAYRTPPAAAPFLCGGSPRSVIPMILH-AAHLWERWSDLTPIVRATSSSAAPASGARST--EELSAFIGAMHIAGLPLAEKIVAAIR-----PGQARNLLDVGGASGTYTIAFLRAAPGMKATLFDRPEVIPMARERLAEAGVLDRVRLEAGDFHRDELPGGHDLALLSAIIHQYSPQENRELFGKVSRALVPGGRIVIRDHIMDPDRT----QPRDGAIFAVNMLVnTRGGSTYTFEEVRAWLEGTGFANVRFL-------------------------------
+>UniRef100_UPI000A3C465B 214 0.454 2.887E-56 9 362 384 8 365 374
+---------LIDYAA-FGSTgaPEEDTVVAAHELYSTLIGLWAPAIIEAAAELGVYPLLRDEPVGSDEIAAELALDPAAVRILLDGLHACGMLRRGLTGGGvPRYRLEDRFAPLLLGTGEYHLLGKMAYDRTVAWPAWRGLAETIRSGGVAPGALPEKNQNSERDFVSLVSGINFWAPHAIESVRTALRaDLGWDLARPTSVLDVGCGTGIYSQLLLRGESTWTATGFDTPKVAEIATAQAARLGVGDRFDCEAVDFLAEDWGPPRDLVLLVNVCHLLPRHLVSELIARAAKAVRPGGCVCVVDHMhLDTKDEFDEPQDRFAALFAVSMLSTGGGDTHRVSDYRHWLTDAGLRPAVLRPTPMHRLLLA---------------------
+>UniRef100_A0A345XPI4 214 0.523 3.936E-56 9 362 384 14 359 363
+---------LVDTTLL--PAGGDGEVQAAHRVYEHLVGIWAPGVVEAAQDLGAFAVLTEGPATAAQIAERLDTDLRATRVLLDGLHAYDILGRvRGDDGQPVYSLPPELHGVFAPGGLYSLAGKITHDRKVAWNAWRNLADNVRSG------TQELNQISEEDYTSLVHGINFWAPPITQVLAKGLREHGWTSGAGRSMIDVGCGTGIYSQLLLNEFPELRARGLDVERIVPIAREQAERLGVADRFRPEICDFWNDDWGNDSSLALFVNIFHLQTAESAHELLLKTSKALAEDGVIAIADHIVDEDKDGST-QNKFSRLFAASMLATGGGDAFTVLDYDKWLADAGLRRIALLDAPMHRVLLA---------------------
+>UniRef100_A0A7C3MML6 213 0.302 7.316E-56 27 364 384 8 339 340
+---------------------------SPQQLMGLLQGFMGSAALKAGLDLELFTHIAHGADTAEKLAAVKKVPERAMRILCDALVAFGALTK----SGGHYSLPPASQAMLVKGSPAYFGAMAgIMCNPLMWNEAGRLADVVRAGHSlLDQGAEAPEHPFWEEFSRRSKQMATMGGPAVAELA----ASLFGAGEPARILDIAAGSGMYGFSALKRFPGARLVSVDWPNVLRLAEPTAKQMGLAERVEFRPGDIFKDDLGTGYDLVLAVNIYHHFGIERNTELSRRLHAATASGGRLIIVDAVPDENREH----ERFALVFALTMLiWTREGDTYTLSEYERMLKPAGYRDIELKAVPgpaPFQAIVARK-------------------
+>UniRef100_A0A4V2PBK1 212 0.452 1.360E-55 8 367 384 14 368 372
+--------SVVD----FEEIGTDRTSESAHAIYAALVAQWQPAMLETASSLGLFGALRAGPLRAEEIAAVTGTNTRAVKVLLDALVAYGWVTSIPDGENSRYSADPAVAASLSSDSIFSLTGKIGYNRGLSRSAWRTLDQSVRDGVRAADGI-GNNEITAHAYEDLVTGINFWAPPIVDKLIDWTTRTGWRREQSRKFLDIGCGSGIYSQLLLRHFSRAVAVGLDVESIGRLAVGQSVELGVDDRFRLRTANFWRDDWGTGHDAVLFANIFHLVNPAGALELLDKARDAVADDGFVFIVDNIAVGGTESDSPQDRFAALFAVSMLVTGGGSTYTLADYDQWLSTTGLERVALIDAPMHRIVVARRTEE----------------
+>UniRef100_A0A1G3USZ5 210 0.277 6.404E-55 28 364 384 3 329 331
+----------------------------PDRIIGMASAFYESCVLFTASDLGIFARLSEaGPADAQSLALTLKLDERGVRLLLDACVAMELLQK----EGSHYANTLESKAFLTPGSPGDLSGAIRYNRD-VYTAWGKLKDFVKSGRP-VESPESHLGQDPERTRTFVMAMHYRALGMGRAVIGEL-----DLSGSKTVLDVGGGPGTYSMLIAQANPDATCTVLDLPEVVAVADELIRQQALQGRVKTLSGDYRRISFPEGYDMVNFFGVLHQESPQSILLLLQKAYRALRPGGAVNVMDMMTDSTHT----KPKFSALFGVNMaLTSENGWVFSDLELKEWLKEAGFADCMVKPLPppmPHSFAAARR-------------------
+>UniRef100_UPI0018935592 208 0.407 3.014E-54 9 362 384 20 377 381
+---------VIDYGAFAPTgSDDEKTVIAAHELYTVLIGLWAPAIIEAAHDLGVYPQLSGAGVSSDQVADVLSLPGTASRILLDGLHACGIAERFRSDDGiVRYRLRERFAPLLLGGGAYHLLGKLSYDRSVAWSAWWRLPDSIRNGNPGPGESDGRNQNSEQDFVALVSGINFWAPHVVQQLrAGLAEDLGWDLSHPRSILDVGCGTGIYSQLLLRKQPEWTAVGIETPKVAHIAREQALRFAVADRFDCRETDFLEDGWDVSCDIVLLVNVVHLLPAATAAEFIERASRAVRPGGCLCVIDTILDDSKDTfDQPQDRFAAMFAVSMLATGGGDAHCVSDYRRWLHAAGLRPTAVRETPMHRVLIA---------------------
+>UniRef100_A0A950Y7R7 206 0.274 1.418E-53 32 365 384 0 321 323
+--------------------------------MQMAWSYAPPLIIEAAVRNGFFDALATKPMNASELAQATGSSERGVTAVMDALVGLALAARDRN---GRYVLTAESDTFLVSARPGSLGGFFRHISDLI-PAWLPLRDIVRTGEPARKVDSQETGAA--FFSNFVESLFPLGYPAALGVAKSL---GAPLDAPLQVLDLAAGSGVWSVAIAHTYPQARVTAVDWEGVLPVTKKVTARERVADRYEYIAGDILETDFGGGYDVATLGHILHSEGDARSQELLRKVGRSLKPGGAIVIAEFLANEERSGPP----QALIFSVNMLVnTSAGRAFTFGEIRAWLEEAGFIDARTLEIPAPSLIVARKA------------------
+>UniRef100_UPI000B2CDD0E 205 0.465 2.633E-53 28 370 384 18 361 362
+----------------------------AHQLYAALVAQWQPAMLESASALGIFDVLRSGAASSTAVAKSIGADERSVRVLLDALAAYGWVSGRDGVDGEpLYEVDESVAACLTAGSMYSLIGKIGYNRSVSGDAWRKLDRVVREGISGHDGEIENNGISAVAYEDLVTGINFWAPPIVDKITAWLRAAGWGAGEARDVLDIGCGSGVYGQLLLGDFPAATATGVDAPNILRIAAKQAAALGVGERFEARGADFWTSEWGTGRDLVIFANIFHLVNPSGAEKLLEKARESVADDGIICIVDNIQVGGAETDSPQDRFAALFAVSMMVTGGGATYRLAEYDEWLRVAELERVALLDAPMHRVILARPRREGSS-------------
+>UniRef100_A0A6G9ZAG5 205 0.447 3.588E-53 5 363 384 31 389 393
+-----GRTTLVDYEHFQRSGVGFDEICAAHKVYETLVGLWAPGVIEAADELGVFREIAKSSKTPAELAEVAGAGSHGMRILLDALCVYGLLNRDvDDSDGYKYSLKPFFGSVVTGHGSASLIGKFLYDRQLAWPAWVNFVDAVRN-SGDPDSGRQENQIPAGQYIHLTKGISFWAPPIVDVLCHRLEELGWSSSSEKHILDVGCGTGIYSHLLLRSFRGSQAIGLDVPEICRVAIESASEFGVDDRFATREVDFWSEGWPKNQDLVVIANIFQMLTPDSAKRLIDLAASSLSESGVVCIVDQIRIGKAEFDTAQDRFAAVFAASMLATGGGDTFHLNQYDDWLESSDMHRIDLLDTPMHRIILAR--------------------
+>UniRef100_A0A7V7EA79 204 0.311 6.664E-53 30 370 384 9 333 335
+------------------------------RINEISTGFKGSMILFAANDAGVF-ALLEEERSADELAAVAGWHPRAARMLLDALVALDLIGK----SEGRYRNTPIASACLVPGGKAYQGHIIKHQQNG-WDAWARLEVSLRSG---TAVERDAHERSPEELRAFILGMRDTARISARTMCDVV-----DLSTHRHMLDLGAGPATYAIVFTQRHPELRATVFDVPEVIPIAREQVAAAGLDERFAYIEGDMLADDLGSDYDLVLASNIIHMYGPVENRALMKRCYDALAPSGLLIVKDFLVDDGRSGP----AFGLLFALQMLiHTPCGDTYATSELSEWTNEAGFAEGRLIElTPQARLWLAGKPPARSA-------------
+>UniRef100_A0A7T1WXA6 203 0.299 1.686E-52 34 365 384 0 326 327
+----------------------------------MMSAYKETSVLKAGIKLGVFDELArEEPQDAESLARRLGSDPRGMRILLNALAALELIE----TDGRQYRLPPGAAELLSRDSDGYAGDMIHVIaSDYEWDALKNLDGAVRNGGTVL--DEHAETPEYSYWEDFAAFAPHVARPTARVLADALEPWARD-RESLDVLDLACGHGIYGYTVAQRFEQAAVWSLDWENVLDVAAKHAGSMGVRERTNFIAGDMFDVSFGGEYDLVLITNVLHHFSDERARELLSRAAAALRPGGKIGIVGF---TTSDAPPALDPAPHLFSVLMLVwTSEGEVHSERNYRRMFTDCGLEepSVHQVENLPFRVLLADRA------------------
+>UniRef100_A0A932TFF8 203 0.313 1.686E-52 28 365 384 10 335 336
+----------------------------PRSIMDILWSMVPIRVLTAAVKLQIFAPLEMSPQTAAEVARQVEADARGIRMLLDALVGIGFLTKAGD----HYALTPVARAHLVPGKTGYL-GDYVAGSARMAERWGGLAEAVRTGQPVM--AVDEQETAEEYFSTLVRALQVTNGPPAQRLAAHL----ASRRSAARVLDVACGSGVWGIYYALADPQARITAHDFPTLLELARQYIRNHGVEDRFEYLPGDVRTVDFGvEHYDVAILGNICHSEGEAGSRALLRQMARALRPGGTAAIIDMIPNEARTGPP----FPLLFALNMlLHTREGDTFTLAQYTAWAREAGLERVETVDIGSHsPAILATRP------------------
+>UniRef100_A0A349GW63 198 0.285 1.280E-50 38 365 384 1 318 319
+--------------------------------------FYDSCVLFTASDLGIFNHLAQHPdATAADLASACQLDLRGATLLLDGCVALDLLTKTGD----RYRNTPETACFLVPGAPGDLSKAIRYNRD-VYAAWQQLPAFVKTGKP-VERPEIHLGEDEARTRAFVHSMHGRALGIGRSVVPQLDLAGR-----TQLFDAGGGPGTYSVLIAQANPQIRCTFLDLPGIVKVANELVAAQGMADRVTSIPGDYHTTPFPDGNDVVIFFGVLHQESPASIQDLFRRAYASLVPGGSVYVLDMMTDATHT----QPRFSALFAVNMaLTTTNGWVFSDQEAIDWLTGAGFIGAACRPLPppmPHWLVTATKP------------------
+>UniRef100_A0A7K0ITR6 198 0.293 1.280E-50 28 353 384 2 312 328
+----------------------------PSELLQLSGGYWATCALHAAVKLDLFTCIAGSPATSSEVSRLTNTDHRSMTMLLNAVAAIGLLHF----DNGKYVATPFSAEYLSKNSDKYLGHIIMHHHNLM-PGWSNLDEAVKSGAAVR--SNSSRSDDAADRESFLMGMFNLACLIAPKIVPAIDLSGR-----RSLLDLGGGPGTYAIHFCLHNPELRAVIYDLPTTREFAEQTVQRFGLSDRISFSAGDIITDGIGSGYDVVWISHLLHSEGPAGAATMLDKAVRSSRPDGLVFVQEFILDDDRTAP----LFPALFSLNMlLGTQAGQSYSQQELTQMMINAGVENISRLP------------------------------
+>UniRef100_A0A8J3ZYP0 196 0.298 3.235E-50 25 365 384 0 334 335
+-------------------------MQASADIFHALLAYKKSAMLRTGIELGVFARLAERPATADEVARDLELAPRGSRLLLNALVAIDVLE----ETDGVYRLAPLAAETLDPNRDGYLGElSRILTSRWEWEAMGRLPEAVRRGGPV--IAENAEQLDYGYYEEFATHAGAVTRPTVARMTGTVHDWAAQRER-LNILDLACGHGMYGLTLAQQHPHARLWSVDSAKVLEIAQKNAARLGVADRMQTIAGDMFTLDLGGPYDLALITNVLHHHTPERATELMRRVAAVTRPGGKLVLVGITADDGPVRESPE---AHLFSLLMLVwTDNGEAHSAGSYERMLSAAGYRDMRlyRQDEIPMRVIVAERA------------------
+>UniRef100_UPI0018675D04 184 0.381 4.614E-46 28 366 384 23 356 358
+----------------------------AHRLYSALISSWETAIIEAAYNLGIFSCVASGPATLFEIAKRTACNEECLRILVDALVAYGwLFTNAMPGSDPTYHLPEEYSDVLTAvEGVNDLTGKIYYDQEIAWQYWRNLAHTVKTGSVRN-----VNGISTATYRQLVLGIRFWAPPIAAAIGKALDK-HHFLREDRLLVDIGCGSGIYSHLLLQQHHGLRAVGYDVPEIADIAHESAGKFGVSSRFRMVTGDFFESDW-AAADLYLFANIFHLFDPEKCKILLSKARAGMSDDGRVLIVDAIRASGGSPVTSQEKFAALFAVSMVASGGGNTYSLNTFDSWLAELGLYRIDYLNTPMHGVIVAGWLP-----------------
+>UniRef100_UPI001FC9146D 181 0.559 7.376E-45 111 364 384 1 254 255
+---------------------------------------------------------------------------------------------------------------FAPDGLYSLAGKITHDRNVAWQAWRHLADNVRGGARGEHGGQQVNQISEEDYTSLARGINFWAPPVVSVLADALRERGWGDDTEAVLLDVGCGTGIYSHLLLQAFPQLTARGLDAPRITAIAAEQAERLGVSERFSPLTADFWNDDWGNGTDLALFVNIFHLQTPESAHELLLKTAKGLGEGGLIAIVDHIVDEEAGSGNVQNRFFRLFAASMLATGGGDAYTVHDYDQWLADAGLRRVALLDTPMHRVLLAGR-------------------
+>UniRef100_A0A938CP11 167 0.283 3.444E-40 35 364 384 20 343 344
+-----------------------------------AFGILAAEAVLAGLRLGLIEEVAARPATARQLARKVGAKERGVRVLLDALVALGQLGK----EGEQYCLSASTQMLLsLPGVDaKSYCADALLHLSAFSDGLRQLANVVRTGRPPSADPADTE----RFLVALAGSLFPFNYPVARALCHRIR--GEFGRGPLAILDVAAGGAPWSMPFAQGNRQARVTAVDFPAVLEVARHYAQAAGVEGQYELLPGDIRKAPFGNGqFDLAILGHICHSEGPNRTPRLFRKVAQALKPGGVMLVLDFVADEHRTG-EGSGALALLFALNMLVSaTDGDTFTESQYRLWGVQAGFSGPERLELPaPYPALLFRK-------------------
+>UniRef100_A0A3M1IMN7 153 0.300 1.529E-35 138 365 384 0 218 221
+------------------------------------------------------------------------------------------------------------------------------------------PEVVRTGRPVPRDRRPA-----EEFARFVEALFAGNLPAAQALQAHL--GLRQTTAPCRVLDLGAGSGVWGIGLAEGAPQVRVTAVDWPEVLAVARRLAAEHGVAERFRWIEGDFFEVGLGNDYDLVVLGHILHSEGIERVRRLLERSHEALRPGGRVVIAEFLPADDRSGP----LQPLLFAVNMLVnTEAGDTYTLAELTAWLEEAGFEAVETLPVPaVSPLVLARKP------------------
+>UniRef100_A0A7C2IW83 139 0.282 4.702E-31 151 365 384 2 205 206
+-------------------------------------------------------------------------------------------------------------------------------------------------------PPGVEGRDPAWTEAFIAAMHRGALAAAPAMVATV-----GAAKVRRLIDLGGGSGAYSIAFARANPELRAEVLDLASVVPIAEKHIAEAGLGDRVKTRVGDLLKDEFGSGYDLALLSAICHMFSPEENRDLLRRTFRALVPGGRVVIRDFIVEPDKTAP----KWAVLFALNMLVaTRGGATYTEAEYSSWLEEAGFVSIER---PQADLIVARRP------------------
+>UniRef100_A0A1F5BUK4 139 0.309 8.616E-31 150 365 384 25 235 236
+------------------------------------------------------------------------------------------------------------------------------------------------------GLFAKLGEDSERTRTFVLAMHGRAMGIGQAVVPLLALSGRKA-----VLDVGGGPGTYSILIARAFPQITCTVLDLPEVVRIAEEIISQAGVGDRVQTLAGDYHTIAFPANQDAVIFFGVLHQEDPAAIRNLLRRAHGALRQGGSIAVLDMMTDASHT----QPKFSALFALNMaLTTPHGWVFSEDELKAWLVEAGFTDFNCRPLPspmPHWLATARKA------------------
+>UniRef100_A0A7C4C0Z0 134 0.333 2.399E-29 195 367 384 12 181 182
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RRMLDVGGGSGAYSIAFARANPELHADILDLPEVLAIAKRHISEAGLEERIATVAGDLRKDKLGENYDLVLLSAICHMLSVDENQDLIRRCFDALAPGGRIVIQDFILEADKTAP----RTAALFSINMLVgTRDGASYSEPEYVDWLAGAGFSDIRRVRLPGPAGLMAGVRPR----------------
+>UniRef100_A0A7C6B4B6 133 0.295 5.934E-29 192 365 384 4 175 177
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------EGVRRMLDLGGGSGAYTIAFAQASPELEADILDLAPVLRIARRHIEEAGLSDRIRTRPGDLHQRSYGAGYDLVFISAICHMLDPKQNRGMLRKSYRALKPGGRVVIQDFILEADKTAP----RAAALFSLNMLVgTRAGASYSEPEYRSWLQDTGFGGISRLHLPgPTSLMIGRRP------------------
+>UniRef100_A0A2V9K3Q8 133 0.331 8.024E-29 185 356 384 8 176 187
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RLVRLEPGRKHRVLDIAAGHGKFGIAFAREYPKVEIVAQDWPNVLEVARENARAAGVEDRFRTLPGSAFDVDYGSGYDLVLLTNFLHHFDPETCERLLRKARAALAPGARAATLEFVPNEDRVSPPVPATFSLMMLG---STPKGDAYTFSELERMFRNAGFARSELHALPP---------------------------
+>UniRef100_T0ZCY9 129 0.284 1.209E-27 167 357 384 20 205 215
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------RSLHVANRAPAERLAQALEIADRRPLA---VLDIGCGSGIWGIAIAESAPHARVTALDFPQILELTREYATRHGVQDRFEYLPGDLRTAALGtARFDLSILGNIVHSEGEKSSRALFRRLHRATRPGGQLAICDMVPNDERTGP----IYPLLFALNMLVnTTAGDTFTLGEYSAWLGEAGFTEVRTCEIGSH--------------------------
+>UniRef100_A0A831XJT3 127 0.308 7.352E-27 190 366 384 18 191 192
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DLSGFKHLLDLGGGPGTYAIACLNAHPQIRATLFDHANVVDIAREQVEAAGVSDRVTFVVGDALKDDLGDGYDVILMSNLIHAFDENENRRVVGKCFDALASGGRLIIKDFLVENDRSGPP----FALLFALHMFvHTQGGDTYTFAQVEEWTSAAGFSEGRALPLTPHTHVWLADKP-----------------
+>UniRef100_A0A838MY84 126 0.295 1.811E-26 196 364 384 4 169 170
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------KILDIAAGHGIFGITLARHNPQAEVFAVDWPNVLQIARENAETAGVAARYHLLPGSAFEVEFGDGYDLVLLTNFFHHFDQPTCESLMRKVHAALKDGGRAVTLEFVPDEDRVSPPAAATFAMVM---LASTPSGDAYTFSEYEQMFRNAGFTHSVGYPAPPGHIIVSQK-------------------
+>UniRef100_A0A1V5YR16 125 0.325 3.301E-26 197 364 384 0 165 166
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------MLDLAGGPGTYGITFQQQHPELHVTLFDRPEVVTIAREQVSEAGLSSRFSFIGGDCICDDLGNGYDLVFLSNIIHSFGTEENAGLMRRAYDALVPGGTLIIKDFILDNDRQGPAYGLMFAL---QMLVHTTAGNTYSFEEIQRWTDAAGFRQGESISlTPQTRLWIARK-------------------
+>UniRef100_A0A9D6DY32 123 0.266 1.479E-25 137 367 384 0 224 225
+-----------------------------------------------------------------------------------------------------------------------------------------MSEVVRTGRPVAAVNREKDG--GRFFSEFVEGLFPVSYPAAQALSEVLEISQSK--EPVHVLDLGAGSGVWGIAMAQKSSHVRVTAIDFADVLPVTRRVAQRFGLEEQFHYVAGDVLEADFGGGHNIAVLGHILHSEGEKRSRTLLRKTFDALAPDGTIAIADFIVNEERTGPPP----ALIFAVNMLVnTEHGDTFSFGEIKTWLDQAGFENARpVEANGASPLILATKPGR----------------
+>UniRef100_A0A924W8C4 122 0.328 2.694E-25 195 346 384 16 164 184
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GRVLDVAAGHGLFGIVIAQRNPGARMTALDWPKVLEVAKLHADRMGVGERLTTIAGDAFEVDLQGPYDLILLTNLLHHFDAQQCTTLLKRLRAALRPGGRLVTLEFIPNEDRVSPAMAATFPLVM---LATTARGDAYTFSELEHMLRAAGF-------------------------------------
+>UniRef100_A0A950V3E9 121 0.327 6.615E-25 194 355 384 3 161 173
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PMKVLDVAGGHGLFGIAFAKQNPNAEVTLLDWAAVAAVGTENARKAGVEKRFKVLAGSAFDVDYGTGYDVILLTNFLHHFDPATIDKLLKKVHAALKPAGRVVTLEFIPNEDRVTPPIAAAFPMLM---LCGTPSGDAYTVSEFQKMFRAAGFSNNIFIPLP----------------------------
+>UniRef100_A0A2W2EUZ9 120 0.308 1.204E-24 197 365 384 5 173 175
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------VLDVACGHGLYGLTLAQRNPRANVWALDWPNVLTQVETHADQLGVRDRLHQVPGDMFQVPLGGPYDAILVTNVLHHFSEQRAGELLARLAPALKPDGKIVLVGFTLGDE---NPADDPAPHLFSILMLaWTYEGEVHSIAAYDRMLTAAGFTTGRRHDVPGlaFRVLVADKA------------------
+>UniRef100_A0A2V5V6K0 119 0.244 2.952E-24 194 364 384 8 176 178
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PVRVLDVAAGSGIWGIALAQQSPLVRVTAQDWPEMIPTTKRITQKFDVADRFSYVEGDVLEANFGTDYDIATLGHILHTEGKDRSRKLLKKVFGALKPGGTVAIGEWLVNDERTEPLPSLIFAV---NMLVHSERGDTFSFNEIKRWLEETGFKKVRKLEAPgPSPLILATK-------------------
+>UniRef100_UPI00215D97BC 119 0.288 3.979E-24 130 365 384 0 224 226
+----------------------------------------------------------------------------------------------------------------------------------MVKGWLRLPEAISGGHP------EPQGPDPEFFTHLTRGLLAVNWPEATELAGQL-----KSRGYQRLLDVGAGSCLWSAALLKELPSARAWAIDFPQVLDgSAQEIVRHLHLEDRFVFLPGNYWKISWGEGYDLIILGHICHSLGPEENVTLFKKARQSLARDGELVIIEFIPDEGRCSPLFPLIFAL---NMLLHTDSGDTYTASEYQDFLARAGLKISERlyLDQGHGSQVIVARP------------------
+>UniRef100_A0A2V6IMK1 117 0.269 9.748E-24 196 364 384 15 181 183
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RVLDLASGSGIWGIALAQKSPRVQVTAVDWVGMIPTTKRITQKFGVGDRFKFIGGDLLKADFGDGYDVATLGHILHSEGRDRSRKLLKKTASALKSGGIIAIGEWLVNDERTEPLN----GLMFAVNMLVnTESGDTFSFNEIKRWLDEAGFKNARTLEAPgPSPLVLATK-------------------
+>UniRef100_A0A0F5VJF9 117 0.293 9.748E-24 138 363 384 0 218 219
+------------------------------------------------------------------------------------------------------------------------------------------PGVVRMGGPRAGG--ETEVADNPHGEGIVRAIPAVSVPAADA---GVDALGIADAGEISILDVGGGSGIYSSIWLKANPAARAVQLDWEPINVIARRLVGEQGVGDRFTTLDGDFHTTDFGTGlYDIAVYSHIAHQENAHSNIEVFTRLRKALKPGGALVVADYVVDEDRGAP----AFPLLFALEMlLKSNEGGTWRRSDYRDWLIKAGFEDVSFHAAPPATMVIAR--------------------
+>UniRef100_A0A7Y2F7Z1 117 0.269 1.314E-23 210 365 384 0 151 155
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------ALLQKNPELTAVVVDRPEVLRVAEEMATEYGVIDRVELMPGDMFDEPLPSNADIVLLSNVLHDWDVPECQQLIYRCVESLAPAGRVVIHDVFLHDELDGPLP----IALYSAALFTLTQGRAYSQREYREWLEAAGLRTVPAVDTLIHCGIIVGQK------------------
+>UniRef100_A0A9E2XDP0 117 0.270 1.771E-23 158 361 384 0 197 202
+--------------------------------------------------------------------------------------------------------------------------------------------------------------DHPIWVKFARAMGPSRVPVAKIVASEL-----AVPSPRKVLDVAAGHGMFGIAIAQATTGAQITAIDWQAVLSVAQENAEAAGVSGRYHTLAGSAFDSDWGSGFDLVLMTNFLHQLDRDACVTLLRKARKSLVSGGRAVAVEFLPNEDRVSP----RFPAMFAFQMLgSTPQGDAYTAREFEEMGRAAGFGKViaKSLPPTPHSLIL----------------------
+>UniRef100_A0A354C2G1 114 0.267 1.426E-22 197 357 384 0 157 168
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------MLDVGGASGTYTIAFLRTVPDMRATLFDMPEVVEMARERLSKAGMLDRVTLVSGDFYQDEFPPGHDLAFVSAIIHQNSPAQNVDLYHKIFRSLDRGGRIVIRDHVMEPDRLHPKDGAIFAV---NMLLGTSGGGTYTYEEIKADLSQAGFTAVRLIKRGEH--------------------------
+>UniRef100_A0A2M7Z0A8 113 0.294 2.585E-22 190 361 384 11 180 194
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------SLKAVRSLLDLGCGPGTYALAFLAQNPTLHATVMDRPAALDVARMLAEQSSSGTRLTYQAGDFLTEHISGTYDVVWYSNVLHIYSPADNLKIFKKVKRILNPGGRLLIQDTFL---HDPTELQPLEANLFAVSMLLyTERGNTYSVRDVREWLQRAGLTRSRVLHLKEGTGDW----------------------
+>UniRef100_A0A955WEZ4 110 0.248 2.783E-21 201 366 384 0 164 166
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GGGPGTYSALLAQANPELSAEVLDLPGVVAIAREIVGSMGVGDRVTCSPFDYYRDTLAGQYDAALISGVLHREQPAQVQAILANVARVVEPGGVLYISDVMLDDDRVGPV----FAAMFALNMRVLaHDGRCHSVAEQRAWLDEVGCKvtDVTHLPAPIHYTVIRAEKR-----------------
+>UniRef100_A0A931VA74 109 0.323 3.744E-21 198 364 384 0 166 167
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LDIAAGSGVWSIAFAQEFRSATVTALDFPAVLKVARAYAGKFGVGHRFKYLSGDLRRLDFGkQQHDLIILGHICHSEGRANTIRLLRKSYAALRKDGQVLIADFLPNNRRTGPVMPLMFAL---NMLLNTTEGDVFSVAEYQKWLRAAGFKKIELLRsaPAPSPLILAAK-------------------
+>UniRef100_A0A2V6FEX5 108 0.250 9.108E-21 207 364 384 1 156 158
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------WGIVLAQKSPRVQVTAVDWAGMIPTTKRITQKFGVGDRFKFIEGDLLEADFGESYDIATLGHILHSEGEDRSRKLLKKTANALKSGGTIAIGEWLVNDERTEPLN----GLMFAVNMLVnTERGDTFSFNEIKRWLEEAGFKNVRTLEAPgPSPLVLATK-------------------
+>UniRef100_A0A7Y5FDI1 108 0.304 1.647E-20 195 354 384 21 177 189
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------KNMLDVGGGSAAFSMEIVKKNPSISAVVLDLPYVIPLTKKYVSGAGLSDKFNFIEGDYLTTELKDNYDLILLSAIVHINNYDQNKMLVKKCADVLNKSGMIIINDFVMNEDRT----QPRQSALFALNMLVgTENGDTYTEKEMREWFESAGLSKIERKNT-----------------------------
+>UniRef100_A0A938CHE3 107 0.308 2.976E-20 211 368 384 0 154 158
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------MLKRLPDATALIFDLPTVVAIARECAELAGVSDRVETRAGSYWDDELGEGFDLAIVSNILHSSGPEGCVTILQKTLRALAPGGRAVVHDFILGEDGTTPP----WAALFSLNMLNAGnEGRSYTRGELEEFAAEAGFEATEYRQCTEDTGVVVARKPVP---------------
+>UniRef100_A0A2V8H5I2 104 0.272 2.353E-19 215 364 384 0 149 151
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------NPQTRVTVVDLPGVVEtVTRRFVAREGLSERFAFWPGDLQQIDFGESaFDVIVLGHICHGEGAERTQELLHRAFRALRPGGQILIAEFVPDDDRNGP----LMPLLFALHMLVlTERGDTFTLGEFTEWLTTAGFVDIGTIAAPaPSPLIVATK-------------------
+>UniRef100_A0A3C1Z2Q6 104 0.270 2.353E-19 195 353 384 11 166 180
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RTMLDLGGGAGTNAIAFCRVYPGLSATVFDLATTLPLTTRTVKDAGLEDRIALKSGDFNRDALGGPYDVVLMSDILHYQNLATNAALVKKIHGHLSPGGRLVIKDRFLDPSGTSPAWTAAFAVHILVN---TEQGACYRTAEAMQWMHDGGYVSVEEIE------------------------------
+>UniRef100_A0A2S9FNB9 98 0.375 1.447E-17 195 306 384 0 111 126
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RSLLDIGGGHGWYSAQLCRRYPRLTATVFDLPGSAAIGREIIAGAGMADRVVHRDGDATTDDLGTGYDAVLCFNLLHHMTAEQTVHLFGRIHTALAPGGTLAVMDAFAEPGR-----------------------------------------------------------------------------
+>UniRef100_A0A7V9GF58 97 0.333 3.487E-17 197 365 384 2 169 171
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------VLDLGAGACPWSRALAQADAEIRVTAVELPGVAAITRRSIADHGLGDRFRVVEGDLFRAEVGTGFDLVLIAGVCRLFGPTANALLARRAAALVRPGGEVAIVDALPDADRSDGRSNALYALGLA---LRTSTGGVHHLSAYASWLYDAGLAGIElvELDRPELSLVRATRP------------------
+>UniRef100_A0A7V9QC46 96 0.280 8.394E-17 192 361 384 2 161 168
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PHAREMLDLGGGPGTFARAFARR--GLHATLLDRPEVIELVAERYDLRSIPE-LSLQSGDFLDDSPAGEFDIILLANITHIYDPATNTRLIGSLVPQLRPGGVLAILDFVR--------GLSEFAPLFAITMlLNTEQGGTYALEEYTRWLEEAGLGEVRCTSIDLDRQLV----------------------
+>UniRef100_A0A7W0Q6F8 96 0.327 8.394E-17 194 366 384 39 209 639
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GGSLLDIGGGAGTYTAALLDAHPAATATLVDEAAVIALARQTLARFG--DRVTYVEGDAREVALGDRHAAVLLANVLHLHPPAVCAELCAIAAAAVMPGGQVIVKDLRVDVDHAGPLE----GLMFALNMAVyTDGGDVHDTVQLRNWLATAGLVDIiehRQEAAPDGIVVIGRRPR-----------------
+>UniRef100_UPI00227925D2 93 0.336 6.492E-16 42 151 384 8 113 129
+------------------------------------------KVLHSAVALGVFGALADGPADADQVAAATGLHERMAPDFLDALAGLGLLERTGD----RYGNSPLAEAYLVPGTATYLGGFVELTNETLYGTWGRLTEALTTGPRSTSTP----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A955TCB0 93 0.250 6.492E-16 215 353 384 0 135 145
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------HPGLSATVFDLPQTLRVTKDHVDRAGLGDRIHLQAGNFHVDAFQGSYDLALMSDILHYQDGSTNAALVKKVFACLTEGGRLIIKDRFLDPAKTSPAWTTAFAVHILVN---TECGECFTIQDSRQWMEQAGFRIVEELE------------------------------
+>UniRef100_A0A7X0B2G6 91 0.270 2.788E-15 172 299 384 59 195 245
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------WSSARGKIRAREIILDRIDWRGDERVIDIGCGRGLFTIAAARRVPRGHVIGIDIWQTEDLsgngpgaVIANAAREGVSGRVECRSADMRNIPFPdDSFDVVISSAAIHNLyDPADRARAIREIARVLAPDGRLVISD------------------------------------------------------------------------------------
+>UniRef100_A0A6I4PU19 90 0.333 8.927E-15 47 154 384 52 156 211
+-----------------------------------------------GVRAGVFARLADGPATRAELGEGLGLKPPALHDFLDALVALGLLER---RDGGRYANTAESDFYLVPGKRYYMGHYLTFVDNFMRPTWDGLAEMLRTGKPPAPQARRP-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A2V6KNM4 89 0.236 1.194E-14 223 365 384 1 141 142
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------VDWAGMIPTTKRITRKFGVADRFQFIEGDLLEANFGNGYNIATLGHILHSEGEERSRQLLKKTFRALKSGGTIAIAEWLVNDERTEPLPSLMFAV---QMLVNTEKGDTFSFNEIKGWLEEARFKRVRKLEAPgPSPLILATKP------------------
+>UniRef100_UPI002021C978 88 0.282 3.813E-14 193 305 384 43 155 242
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PPTRVLDLGGGPGVVAARMAERWPGTRVTLIDIDPVLL----TLARDGVPPSVTVLDADLGEPGWTEaagtGYDLVTAVMTVHYLRPESIRALYRHCRQAMSPGGLLVVADLIPDDN------------------------------------------------------------------------------
+>UniRef100_A0A933SQF1 87 0.295 9.097E-14 226 357 384 1 129 141
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PPVLEAARQYIQRYGLEDRVGVRPGDFLTDDMGSGYDLVLLANVVHMYGAENSSALIKKSAAALASGGRIIIHGFCVDGDGTGPMEDVLFNLNIG---MLTDAGRAHPVEEITGWLERAGISRVRHFRIEGH--------------------------
+>UniRef100_A0A560H420 87 0.262 9.097E-14 172 299 384 59 195 245
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------WSSARGKIREREIILDRIDWRGDERVIDIGCGRGLFTVAAARRVPRGHVVGIDIWQVEDLsgngpgaVIANAAREGVSGRVECRSADMREIPFPdNSFDVALSSAAIHNLyEAADRARAIREIARVLAPDGRLVISD------------------------------------------------------------------------------------
+>UniRef100_A0A1Z4QIT9 86 0.264 1.215E-13 194 351 384 42 209 225
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PLKVLDLGAGTGLYSGMVQAVFPNAEFTLLDLaPEMLEKAKSRFSKMGKSPKI--LIGDYVETDLGGSYDLVISALSIHHLSDVDKKRLYQQVYHVLSPGGMFVNADQVLgkTPDLEKLYRQNWLDSVIAKGISQEDLKAAQKRMEYDrmtpldiqlAWLDAAGFQDVDC--------------------------------
+>UniRef100_A0A163GAS4 86 0.238 1.623E-13 193 299 384 49 155 223
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PGQRILDLGCGTGTLTVQLKQSYPESEVTGLDIDPdVLRMAEAKAAQRHLS--IKFDQGNSYELPYPDhSFDRVVTSLMFHHLTTTNKLQTLKEIFRVLKPEGELHIAD------------------------------------------------------------------------------------
+>UniRef100_UPI0021A33580 85 0.240 2.168E-13 194 299 384 50 155 223
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GQRILDLGCGTGTLTVQLKQSYPESKVTGLDIDPdVLRIAEAKAAQRHLD--IKFVQGNSYELPYPDhSFDRVVTSLMFHHLTTTNKLQTLKEIFRVLKPEGELHIAD------------------------------------------------------------------------------------
+>UniRef100_A0A1F8NFU5 85 0.286 3.866E-13 188 299 384 38 150 193
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LLPFEGTARIrgLDLGAGTGVLAEGILRRYPLAEVTVFDLSdNMLAAARERLRK--FENRITFLKGDFSKDEFGIGYDLILSGLSIHHLTNPHKQQLFRRIYLALNPGGVFLNRD------------------------------------------------------------------------------------
+>UniRef100_UPI0015517974 85 0.272 3.866E-13 192 299 384 45 152 218
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DSGQRVLDLGCGTGTLTLLLKQVYPKAEVTGLDIDPnVLRIAEKKAVDMGMD--IVFNQGMSFELPYPDhSFDRVVTSLMFHHLTLENKLRTLKEIFRVLKPQGELHIAD------------------------------------------------------------------------------------
+>UniRef100_A0A4R4UIL7 84 0.298 5.161E-13 190 300 384 76 189 236
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RLKGGERLLDLGCGRGAVLTLAARRLDEGHVTGLDqRSKGAPRARANAEREGVADRVSLVVGDLRDLPFeDGAFDVVVTDQAIHtITRPAGREQAVREALRVLRPGGLMLIADP-----------------------------------------------------------------------------------
+>UniRef100_UPI001942DF3D 84 0.285 5.161E-13 190 304 384 40 154 244
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------HGGAPARCLDLGGGPGVLAERMAARWPSCRVAMVDLDPVLL----TLARAGVPDTVAVIDADLGSGSWahcaGRGHDLITSVMTVHYLPPSGIRRLYRECRDALAPGGLLVVADLMPDD-------------------------------------------------------------------------------
+>UniRef100_UPI0018F5EC24 84 0.275 5.161E-13 193 304 384 47 158 264
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PPRRVLDLGGGPGVLAERMARRWPSAAVSLLDLDPVLLALARSA----LPGRVSVLDGDLASAGWtalaGGGHDLITVVMTLHYLPAERARAVYAHARRCLAPGGVLIVADLMPDD-------------------------------------------------------------------------------
+>UniRef100_A0A6L4ZQ25 83 0.237 9.196E-13 213 364 384 0 151 152
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------KQYPEANVIALDFPGVLSVTRQYVQQLDAEAQYDYLSGDLNTLSFGKNcYDLVILGHICHSEGERRARKLIKKSAQALRDGGTLLIAEVLPNEDLSSP----LLAMLFSLNMLVfTSEGDVFPASQYQKWMAEVGLKEFEVLDkiPSPFPLLLATK-------------------
+>UniRef100_A0A941ADV1 83 0.338 9.196E-13 24 153 384 451 574 587
+------------------------PVRNVDDLMTVGHGYQRSMVLLAALRLGLFRALAGGAAVAGVLARRVGADAKKLSILLDALAALGLVEK----RGRRYRNAKPARDLLLPG-PHSKESILLHHLDG-WGEWGRLPSTIRAGRNPRAGAQG--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A388RG35 82 0.292 2.185E-12 20 108 384 18 102 108
+--------------------DPARPVLTPERLLQLGMGFWPAKTLLSAVELGVFTRLADGPLDAPTLTEALGLHPRSALDFLDALVALQVLER----DDGKYRNAPDTA-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A938ND12 82 0.369 2.915E-12 247 356 384 2 108 119
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------FLAGDLREGRFGEGYDLALVSAICHMLSPADNAALLGALRRALAPGALLVISDFILDENR----ATPSFASLFGINMLVgTGGGDSYAESDYRAWLAAAGFAEVRCLALPG---------------------------
+>UniRef100_A0A4R4NF76 81 0.298 3.888E-12 190 300 384 76 189 236
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RLEGGERLLDLGCGRGAVLTLAAERLPEGHATGLDQHaREAPRASANAEREGVADRVSLVVGDLRDLPFENdAFDVVVSDQAIHAIARRQgREQAVREALRVLRPGGLILIADP-----------------------------------------------------------------------------------
+>UniRef100_A0A7W0ZUZ6 81 0.269 3.888E-12 197 298 384 44 143 272
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------ILDVGCGTGEITSRLAGEFPRATIVGVDiIEPHLALARTRYPE--LADRVTFREADAFELPFaAGSFDLVVCRHMLQAIPHPE--RVLAEMVRVAKPGGVLHII-------------------------------------------------------------------------------------
+>UniRef100_A0A533ZC60 79 0.313 2.185E-11 252 353 384 0 98 108
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------FHRDDLGGPYDAVLMSDILHYQDPDANAALVRKVHRALAPSGRLVIKDRFLDDGRTSPAWTAVFAVHILVN---TDKGRCYTMAEAVQWLKDAGFTSVDELD------------------------------
+>UniRef100_A0A968BQZ9 79 0.261 2.185E-11 195 299 384 20 124 172
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GRIIDVGCGSGATNLVLAERFPRAEIVGIDLSdPLLRLAREATANTSFGDRVAFERADVQQIPYdDDSFDVAISTNMVHIV--EHPLRMLGEIERILAPDGHLFIVD------------------------------------------------------------------------------------
+>UniRef100_A0A923PGD4 78 0.308 3.880E-11 182 300 384 44 160 217
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RALQQLPISPAANISILEVGCGTGHNLVALAKYFPNAYVTGIDLSEdMLAIAAKKVARFG--GRVTLEEGAFGVVPLEEKYDLIVFSYCLTMVNP-DWDKLLEVARKSLPPTGMLTVVDF-----------------------------------------------------------------------------------
+>UniRef100_A0A4R7V7R0 78 0.282 3.880E-11 198 305 384 50 165 260
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LDLACGPGAISDRLLRRLPKARSVAVDVDPVL-LAIGQAALGDVAGRLRWVRADLRDQDWtdalgadgaDGTFDAVLSSTALHWLDPATLVATYRRAYRLLRPGGVLLNADYLPHPE------------------------------------------------------------------------------
+>UniRef100_A0A401FX31 78 0.261 5.170E-11 195 299 384 47 151 201
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GKILDVGCGFGAVAIELAKTFPDAEITGIDLgEPLLRLGESEARKAGVADRIHLLKGDVRKTEFPtDAYDVVTNTFMLHIV--ENPIAMLNEIERVTKPEGKIMITD------------------------------------------------------------------------------------
+>UniRef100_A0A957TIY1 78 0.280 5.170E-11 193 304 384 42 153 205
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PPGRALDLGCGFGRACRYLAQH--GWQCDGVDFvEQAIVTARQRAADAGVADRITFHVGSVGELDFlQPPYDLAIDVGCFHAQPEAVCVQYAKHVARLLKPGGLFLLFAHLRDE-------------------------------------------------------------------------------
+>UniRef100_UPI00030C1C4B 77 0.264 9.176E-11 192 301 384 98 214 269
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DGKGKLLDIGCGSGAMSIKAAKKFPDVVVTGMDywgagWDYSKTLCESNAKIEGVAERITFQKGDAAKLDFsDGTFDAAISNFVFHEvMSQPDKFALVREALRVVKPGGYFVFEDIF----------------------------------------------------------------------------------
+>UniRef100_A0A532DC31 77 0.274 1.222E-10 241 352 384 0 109 128
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------MGHRLSYLPLDFIKHAIPGRYDVVWLSNVLHIYSPAENRKLLRNIARVLAPGGRLLIQEALLHDRHD---LAPLGANLFAVTMlLFTDRGNTYSVREATDWLMCSGFQRVSLL-------------------------------
+>UniRef100_A0A2W2GWE1 77 0.294 1.222E-10 196 306 384 79 186 243
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RALDVGCSEGAFTRRLARAYPEAECVGVDVSAQA-VARAAAKAAGTA---RFVALDFLNDDPGGIFDLVICAEVLYYVGRGERLRLiFERFRTFMAPGGVLVLVHEWPEARR-----------------------------------------------------------------------------
+>UniRef100_A0A1J5AV34 77 0.300 1.222E-10 194 303 384 34 144 256
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GGPLLELGCGTGRLAIPLAQA--GYQVTGVDLSPaMVTIARDKAARAGVTQRVTLIQGDYTDTPLGGPYRLafVVMNTFLHLLSQADQLAALRHWAAHLTAGGLLLIDVMYPD--------------------------------------------------------------------------------
+>UniRef100_A0A0F9AVU4 76 0.250 1.628E-10 240 365 384 0 122 133
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GKGVKLNYKGGDFTCDSIGNSYDLILVSQIYHAYSEAASLELTKKCHDALVPGGRIAVQEFAISKDRTSPPG----GALFSVNMLVgTEGGNTYHTSHISDWLKEAGFKQVKVKTLSETVLVTARKP------------------
+>UniRef100_X1UPS3 76 0.291 2.168E-10 232 365 384 0 132 138
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------AEKRLTEAGLSDRVTLVAGDFYEDDLPTGPDFTFLGAIAHQNSREQNRALFVKVHAALAEDGLIVIRDVVMDPSHTSP----QAGALFAINMLVaTPAGGTYTFDEYAEDLTNAGFTDITLVhrDEFMNSLIRAKKK------------------
+>UniRef100_A0A2P9H162 76 0.291 2.886E-10 178 296 384 28 142 265
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RTVAEKLAASLPAGEKFDSILEIGCGTGSLTELLRRRFPRALIYAVDVArPMIDLARERI---GECSRIHWHVADARQFRPGRDFALIISSSALHWMTP--VSETVKRLAGMLEPGGSLV---------------------------------------------------------------------------------------
+>UniRef100_UPI00035C64DE 75 0.293 3.842E-10 198 308 384 49 163 262
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LDLACGPGTISARLLERFPKARCVAVDIDP-LLLAIGQGALSTMDGRLHWVDADITTDSWlqaigDEQFDVVLSATALHWLTPAQLITTYRDISAALRPGGLLLNADRLEFDERSP---------------------------------------------------------------------------
+>UniRef100_A0A960X0C7 74 0.300 9.061E-10 244 360 384 0 114 118
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RVSFTGGNFFTDDLP-QADVLLFGHILHDWDLETKLMLLRKAYAALPPGGAVVVYDSIIDDER----KKNAFGLLMSLNMLIeTPGGFDYTGADCMGWMRQVGFQEccVEHLVGPDSMVI-----------------------
+>UniRef100_A0A5C7FQJ3 74 0.292 9.061E-10 196 300 384 53 155 213
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RILEVGCGTGHNLVSLAERFPAAEITGIDLSqDMLSIARKKLRRFG--GRVSIVHGAFGSDSFREQFDVVLFSYCLTMVNP-GWDTLIEVATASLRDNGVLVAVDF-----------------------------------------------------------------------------------
+>UniRef100_A0A938BIS1 74 0.289 9.061E-10 193 296 384 40 142 255
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PPLNVLDLGCGDGRHSLEMARR--GYTVTGLDLSeELLTRARERADDAGLT--LVFRQGDMREIPYMQAFDLVvnFFTSFGYFATDTENARVLHAIARSLRPGGRFL---------------------------------------------------------------------------------------
+>UniRef100_A0A7W7G205 73 0.317 1.604E-09 249 353 384 133 235 254
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PGNFLTDtHLPDGHDVVLFSMILHDWDQATNRELLAKAYEALLPGGLVVVSELLLNAERTGPAP----AALMGLNMLVeTEGGRNYSDAEYGQRLTGAGFTEVRTVP------------------------------
+>UniRef100_UPI001CC7CCF7 73 0.245 1.604E-09 197 299 384 203 308 605
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------ILDIGCSVGVSTRFLADKFPEAKATGLDLSPyFLSVAQYKERERALRKNpIKWFHANGENTGLPsKSFDLVSLAFVIHECPRRAIIGLVEEAFRLLRPGGIIVLTD------------------------------------------------------------------------------------
+>UniRef100_A0A2V6APU7 73 0.281 2.135E-09 258 365 384 0 105 106
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GEGYDIAILGHILHSEGEDRSRKLLKKTANALKPGGTIAIGEWLVNDERTEPLN----GLMFAVNMLVnTERGDTFSFNEIKRWLEEAGFKNARTLEAPgPSPLVLATKP------------------
+>UniRef100_A0A7Y5VEE5 72 0.301 2.840E-09 196 300 384 52 156 212
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RILEVGCGTGHNLRNLALHFPNARITGLDASaDMLAIARSRTRQFPERIQLVEKPYALGEEGFREQYDLVLFSYSLTMINP-QWEELLQQACKDLKPGGFIAVVDF-----------------------------------------------------------------------------------
+>UniRef100_A0A7Y4TBV2 72 0.333 3.777E-09 190 300 384 40 151 218
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DPRPSERILDVGCGTGTLAVLLKRRMPSCEIVGLDPDPqILELAREKARSAGVA--IDFRQGFARDANtlGGTGYDKVVSSLVFHQTPMAEKSVGLRSMAAAAKATGELHVADY-----------------------------------------------------------------------------------
+>UniRef100_UPI0021F385A6 72 0.321 5.024E-09 26 109 384 2 81 90
+--------------------------PGVFDVIDMMTGYQPAAALTAAARLGVFDVLADAPLPADAVAARLGTEPRATRALLDALTGLGLL----GTDDGGYTAAPVARR----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A3C0ICS3 72 0.299 5.024E-09 196 300 384 53 156 215
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------SILDVGCGTGVNSAKMARLFPNAHITALDVSEdMLAQAAKRLKPFG--DKVSLVHQPYEKNPAhSERYDLIHFSYALTMINP-QWQDLLEQAQADLKPGGVIVVADF-----------------------------------------------------------------------------------
+>UniRef100_A0A2V5J6W1 71 0.245 6.681E-09 247 362 384 1 114 116
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------FIEGDLLKADFGEGHDIATLGHILHSEGEERSRKLLKKTANAVKSGGTIAIGEWLVNDERTEPLN----GLMFAVNMLVnTENGDTFSFNQIKRWLAEAGFKNARTLEAPgPSPLVLA---------------------
+>UniRef100_A0A2T5C4D6 70 0.271 1.181E-08 245 351 384 17 120 136
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------IKTYTGDYTKDDLPEGFDLVFLSAIIHSNPLETNQQLIKKCFKALNNKGQIIIQDWIMNDERTEPTTGAIFAI---NMLVGTDGGDCFTEQEVSDMLTTAGFKQIQR--------------------------------
+>UniRef100_UPI001F4F924D 70 0.305 1.181E-08 70 154 384 4 85 140
+----------------------------------------------------------------------LGLKPPALHDFLDALVALGLLER---RDGGRYANTAESDFYLVPGKRYYMGHYLTFVDNFMRPTWDGLAEMLRTGKPPAPQARRP-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A7C6B0U6 70 0.312 1.570E-08 31 142 384 8 114 116
+-------------------------------VLELTDGFRVAAVVGAAAELGVFEAIPEQGITADELASRLACSIRGIQVLCDALAGLSLLEK----RDGTYFLPPKLRPVLRESGAETVIPMLQHRMNMM-RGWANLPWTVK-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A7L5YJU2 70 0.288 1.570E-08 244 366 384 1 121 123
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RVTVQEGDFQREGFGRGYHVALVFGVLNGEPPEGRPALIRKVYDCLEPGGKVVLRDFALDDDRAGQPE----AAIFAPDAAGDGVRGLDTRGDWTNWLTAAGFAPPQTlaLPDGVGTLTIAHKPT-----------------
+>UniRef100_A0A0F9D6E6 70 0.288 1.570E-08 205 364 384 3 151 155
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GTYSKELLKK--EFEVTLLDTQGLTEMAKDHLKDTS----VKILAGDFNERLPNEKFDVILLSNITHIYKPEKNEALLSRVEKHLSPGGLIAIVDLIRSKSKG--------AAMFGVNMLvHTAGGGTWTLPQYEKWLHHAGLRLISVKDLKDADqkLLLAER-------------------
+>UniRef100_A0A928TDB3 70 0.287 1.570E-08 194 300 384 45 143 201
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PHRILEVGCGTGHNLQLLRRQFPDADITGIDLSaDMLRVAREKVPGVSLIQRAY--------DAPAGSFDLIVCSYALSMFNP-GWDRAIATAAQDLVPGGIIAVVDF-----------------------------------------------------------------------------------
+>UniRef100_A0A535YYI5 70 0.297 2.088E-08 257 364 384 2 109 113
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LGGPYDLVVMSHVLHHFDEGRCVELLRRAAAATRDDGRIVIQDFVATGDEHG---RDVAAGLFSVIMLVwTRQGEAHPLARLERMLAAAGYGPPEVHPLPqlPTTVLVAGR-------------------
+>UniRef100_A0A552ZP34 70 0.283 2.088E-08 174 297 384 19 148 218
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PWVIDEPQPAVIALAEAGHISGRVLDVGCGTGEHTIYLTRA--GYDVLGVDgAPTAVDIARRNAAQRGVAAR--FAVGDAFELDAfeldaieggAQGYDTVLDSALFHVFDDADRVRYVRSLGRVTRPGGVVLV--------------------------------------------------------------------------------------
+>UniRef100_UPI00068E7623 70 0.274 2.088E-08 196 299 384 89 201 246
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------KVLDVGCGRGLLTILAARKVPLGDVTGVDIwsqeelsENSKEAAVENARLEQVSERIQFEDGDVRALGFrSHSFDKIVSSLCLHaIASRNDRNQAIANLIKLLKPGGEIAILD------------------------------------------------------------------------------------
+>UniRef100_A0A518C5C2 69 0.213 2.775E-08 188 297 384 115 250 293
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GRSKDESVRILDMGTGSGIIAVTIAKQAPQANVLATDVSEkAIVVAKQNAEKHGVSERVEFAAGDLFQAvPSGSSFDVIVSNppyiaqserplmdaHVIEHEPhgalfaDEEgtsvLRRILEEAASFLKPGGWLLL--------------------------------------------------------------------------------------
+>UniRef100_A0A124DZA2 69 0.323 3.688E-08 197 297 384 42 139 209
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------VLDIGCGAGEHTILLARL--GYDVLGMDFaPRAIEQARANAAARGVDAR--FEVGDALRLAGTSTYRTVIDSALFHIFDDADRAAYVRSLHGVCRPGGLVYV--------------------------------------------------------------------------------------
+>UniRef100_UPI00232F94DE 68 0.283 4.901E-08 198 298 384 8 105 188
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LDVGCGDGTLARLLASR--SGRVTGIDLSaEMVESARDQSKE---VENVRFLEADFLEAGgrelPPGHYDLITMVAVAHHLGTE---RALARSAELLAPGGRLAVI-------------------------------------------------------------------------------------
+>UniRef100_UPI000513702D 68 0.317 4.901E-08 195 297 384 40 139 209
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GRVLDIGCGTGEHTILLTRL--GYDVLGVDgAPTAVEQARRNAAAHGVDARFEVR--DALDLGTTPTFDTVVDSALFHVFDADDRARYVRSLRGVTRPGALVAV--------------------------------------------------------------------------------------
+>UniRef100_A0A7C4TB43 68 0.315 6.512E-08 199 271 384 1 73 77
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DLGGSHGLHSIRFCRRYPNLSATVFDLPQALEVARETIAAEEMGDRVAVQGGDFLADDVGTSYDVAFLFNILH----------------------------------------------------------------------------------------------------------------
+>UniRef100_UPI001CEC1545 68 0.273 8.652E-08 198 298 384 27 124 207
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LDVGCGDGTLARLLAAR--AWRVTGIDLSaEMIESAREQSEE---VENARFMEADFFEASggelPLGHYDLITMVAVAHHLGTE---RALARSAELLAPGGRLVVI-------------------------------------------------------------------------------------
+>UniRef100_UPI000C7EEDCD 68 0.310 8.652E-08 196 297 384 41 139 209
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------KVLDVGCGAGEHTIMLTRL--GYDVLGIDFaPHAVAQARENAAAKGVDAR--FEVADALRLGTEPGYQTVVDSALFHIFDDADRARYVRSLHTACRPGGVVHV--------------------------------------------------------------------------------------
+>UniRef100_UPI001FDABEAA 68 0.321 8.652E-08 191 295 384 76 184 224
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PADARRVVDLGCGTGVLAVTAARTLPEASVLALDVSRAAVLsATATAAANGVGDRVEVRRGHLLAGVPDADVDLVLCNPPFHRGNSRDSAvafEMLADAARALRPGGEL----------------------------------------------------------------------------------------
+>UniRef100_A0A7W1S605 68 0.279 8.652E-08 197 299 384 114 224 250
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------VLDVGCGSGVLLFACLKESPTAKGTGIDIydpysfGGTAGVFWKNADVEGLKERVALQQVDARTMPFaGQRFDVIVSSLAMHHVgNAAEQEKATREMVRTLKPSGKIAICD------------------------------------------------------------------------------------
+>UniRef100_A9HJ62 68 0.323 8.652E-08 194 297 384 47 148 474
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PARILELGCGTGFLSAHLRRLFPDAILTVTDLaPEMVERARARLTPLGGDVRYAVVDAE-DPASVGTGFDLICSSLSMQWFTDPAA--TLDRLAARLAPGGMMAL--------------------------------------------------------------------------------------
+>UniRef100_UPI000B2ED3AD 67 0.317 1.149E-07 195 297 384 40 138 208
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GTVLDVGCGAGEHTILLTRL--GYDVLGVDYaPSAVEQARRNAEATGVDAR--FDVADAMDLG-EAGYDTIVDSALFHIFDETDRPRYVRSLHAACRPGGLVHV--------------------------------------------------------------------------------------
+>UniRef100_UPI001E2F3222 67 0.336 1.527E-07 195 297 384 40 139 209
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GKVLDVGCGTGEHTMLLTRL--GYDVLGIDFSPhAVAQATDNAARRGIDAR--FAVADAMQLGNGPRYDTILDSALFHIFDDADRPRYVASLHAACAPGGTVHV--------------------------------------------------------------------------------------
+>UniRef100_UPI0021B59A1B 67 0.305 1.527E-07 195 297 384 40 143 213
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GRVLDVGCGAGEHTILLTRL--GYDVLGIDFaPHAIEQARENATSKGVDAR--FDVADALALGSSElaepGYETIVDSALFHIFDDADRPRYVRSLHAACRPGGLVHV--------------------------------------------------------------------------------------
+>UniRef100_UPI00083A0E7F 66 0.307 2.028E-07 190 305 384 40 156 220
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DPQPGERILDVGCGTGSLAILLKSREPRCEVVGLDPDaEALVIARSKVIRLGLEIGFAQGFAREARDVCGTGFDKVVSSLLFHQVLPVEKRAGIKAMAAAARAAGEIHIADYAEQPD------------------------------------------------------------------------------
+>UniRef100_A0A951AB46 66 0.283 2.028E-07 174 297 384 97 242 283
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RPETEELVELLKAETGKWKPG-SILDVGTGSGVIALSLAKEFPEAKVFAVDVSEdSLVLARANGARLGLNERVQFQQGDLLE-GLGERFDLVvanlpyismsdrhlLSREVLHdpevslfagDHGDELIRKLIEQTPARLEPDGLLAL--------------------------------------------------------------------------------------
+>UniRef100_A0A9C9N7Y1 66 0.292 2.694E-07 195 303 384 35 145 256
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GRILDVACGTGMHAIELARR--GYEVTGSDLSaGMIERARVNAAQAGVKARFEAVSfGELAAALDGATFDALLClgNSLPHVLTNADLAAALFDFAACLRPGGLLLIQNRNFD--------------------------------------------------------------------------------
+>UniRef100_A0A957GH47 66 0.252 3.577E-07 258 365 384 0 107 111
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GAGYDLALVFGVLNGEPPEGRPALIHKVFAALNPGGQIVLRDAVLDSDRAGPSEAALFAL---QMLLATESGGLDTRADWAKWLGKAGFLPPKEIELPgpvGSTLTIARKP------------------
+>UniRef100_A0A7V6DNW2 66 0.269 3.577E-07 193 301 384 47 161 266
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GPAKVLDVGCGDGYATLNVARKLPEFTFAGIDYSaNMIRLAKERLAGLPsLTRRLTFKVGDVLDLGAACGetiFDAVISDRCLiNLADKADQEHAIKEIARHVAPGGYYLAVENF----------------------------------------------------------------------------------
+>UniRef100_A0A651H3F6 66 0.244 3.577E-07 193 297 384 112 242 284
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PPVRILDLGTGGGALALALARRFPEAEVTGLDTSaEALDLAEENAVRNGLADRVRWIRSDWFAgLGQTAGFNLVVANppylteeewataepEVKDHDPRvalvaaddgcAELLRILQEAPARLAPGGRLYL--------------------------------------------------------------------------------------
+>UniRef100_A0A510TTZ0 65 0.285 6.308E-07 195 296 384 39 139 252
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GTLLDLGCGSGDFAVQMAQA--GWTVTGLDLsPEMLTLAEARAEQAGVD--VTWVQGDMRRLTGLGTFDAVTSFDdsLCYLPDLTAVQETLLAAAGVLVPGGYFF---------------------------------------------------------------------------------------
+>UniRef100_A0A937NK55 65 0.330 6.308E-07 196 298 384 36 139 260
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RVLDAACGTGMHAIALAQQ--GYVAVGADLSaGMIQRAQDNAMAAGVDARFEVAGLGKLSARVGTGFDAVLClgNSLPHLLTPADLAAALADFAACLRPGGLLLIQ-------------------------------------------------------------------------------------
+>UniRef100_A0A3C1M550 64 0.244 8.374E-07 265 350 384 1 84 118
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------WYSNVLHIYSAEENQALFRRLYSALSPGGRLIIQDVFLHD--REGLYPEEASLFAVSMLLVTPAGNTYSFSETAEWLRAAGFVRIR---------------------------------
+>UniRef100_A0A497AHF1 64 0.285 8.374E-07 196 303 384 36 145 262
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RVLDAACGTGMHAIALAQQ--GYEVTGTDLSaGMIERARVNADAANVDVRFEAAGfGELARRFAPGSFDALLClgNSLPHLLTSADLAAALADFAACLRPGGLLLIQNRNFD--------------------------------------------------------------------------------
+>UniRef100_UPI000489D375 64 0.317 1.112E-06 196 296 384 38 138 246
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RVLDLGCGAGDLLLAVRRYRPRASLTGIDISPlniQAAVARAKADPYGLES-VTFEAADYLRAQF-ETFGVILAESVLHLIADDH-DGLAAKLAADLAPGGLLI---------------------------------------------------------------------------------------
+>UniRef100_A0A931W3L4 64 0.269 1.476E-06 182 267 384 153 241 347
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RSYAFACLDGKPPLKILDLGTGSGAIAVSLAKELPQARVCAVDISaAAIEVARLNARRHGVEERMEFFCGDLFEPvaEEREGFDLIVAN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_UPI000C7DCED2 63 0.320 1.959E-06 196 297 384 41 139 209
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------KVLDIGCGTGEHTILLTRL--GYDVVGIDFsSNAIEQARANAADNGVDAR--FQVADAMNLAPDATYQTILDSALFHIFDQADRVRYVHSLHGALRRDGLVHV--------------------------------------------------------------------------------------
+>UniRef100_A0A960RG96 63 0.257 1.959E-06 194 296 384 89 216 261
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PLRIVDVGTGTGCIALALALSFPDAVVTGIDASEaALSLARENGLRLGLHDRIHWRHGDGLTGLSPGTVEVVVSNPPYISSDDyralpahirdyepqmalesgpsglEMLVRLCREASALLSPGGMLY---------------------------------------------------------------------------------------
+>UniRef100_A0A518AML2 63 0.280 2.600E-06 192 264 384 127 201 300
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DAPLRVLDIGTGSGIVAICLAKHLPKSQVTAVDLSPqAIEVAKRNAAKHKVDDRVAFVKGDAYqALPADAKYDFI-----------------------------------------------------------------------------------------------------------------------
+>UniRef100_UPI0021BC03F5 63 0.313 3.450E-06 230 315 384 1 86 106
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------ELSRHNAENAGLSDGYQTIAGSAFDVDWGTGYDLVLLPNFLHYFDLPTCAQLLSKIVASLAEDGRIVAVDFVPNEDGVSPPFPEAF--------------------------------------------------------------------
+>UniRef100_UPI002111CB12 63 0.298 3.450E-06 196 296 384 16 116 224
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RILDLGCGAGDLLLALRRDRPRAILTGVDISPlniQAAVTRAKADPNGHGD-LRFEASDYLQARFD-GFDVILAESVLHLI-VGDHDRLAAKLATDLAPGGVII---------------------------------------------------------------------------------------
+>UniRef100_UPI000314BD16 62 0.319 4.578E-06 192 285 384 42 134 207
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PPFGTALDLGCGTGRHAIELARR--GWQVTGVDIvPKAIRLATRRARAAGVDAR--FLKGDITALPaeVGTGYRLILDFGAFHGLTDPERHTMGRQV--------------------------------------------------------------------------------------------------
+>UniRef100_A0A1F8RJ87 62 0.278 4.578E-06 193 303 384 33 145 256
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GAQRVLDAACGTGWHAIALAQR--GFDVAGGDLSaSMVARATANAREAEVTAEFRQAGfGDLASAFGRDSFDAVLClgNSLPHVLDPAHLTRTLEDFAACLRPGGMLIVQNRNFD--------------------------------------------------------------------------------
+>UniRef100_A0A8S9DR76 62 0.245 4.578E-06 194 303 384 39 150 257
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PKKVLDSACGTGMHALALAKL--GFEVVGADFSgEMIAKARSNSVEIGLKARFEVIGfGSLAKNLGAGQFDAVLClgNSLPHLHTQNEVDETLKDFASCLRPGGLLLIQNRNFD--------------------------------------------------------------------------------
+>UniRef100_A0A7Y9JCX3 62 0.308 6.074E-06 192 296 384 51 149 210
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------EPPASVLDAGCGTGRIAVRLAER--GFDVVGLDVDaAMLEVARDEAPD------LDWRHADLASFDLGRRFDVVlLAGNIVPLLEPGTLPAVAERLAAHVAPGGRVV---------------------------------------------------------------------------------------
+>UniRef100_A0A357HZI5 62 0.259 6.074E-06 189 267 384 107 187 279
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RIETAPQRILDLGTGSGALALALATQYPEAQVVAVDQStAALELARENASALELNERIQFLAGSWWTPVMSESpFDLIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A2D7ZK05 61 0.250 1.069E-05 196 297 384 116 242 289
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------SILDLGVGSGAILLAILAERPNAKGLGVDVSEVaLAVARDNAAHLGLAGRCALLRGDWADGLSDAGFDIVtanppyIASEVIETLEPEvrvheprlaldggadgldAYRRLAPEILRVLKPGGRFAV--------------------------------------------------------------------------------------
+>UniRef100_A0A1G6ZTE5 61 0.339 1.418E-05 192 296 384 46 144 207
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DPPARVLDAGCGTGRIAVRLTEL--GYDVVGVDVD-ASMLAVARAEAPGLD----WREADLATLDLGETFDLVlLAGNIVPLLEPGTLAAVAERLAAHTAPGGRVV---------------------------------------------------------------------------------------
+>UniRef100_A0A944PRW7 60 0.292 2.495E-05 198 298 384 25 122 216
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LDVGCGEGALVRTLARQVEA--VTGVDCStEMVRLARER--SLGV-PNVTFAEADFLDGSHGlltqGGYDFISAVAVIHHV---RFAEAIRAMVRLLAPGGRLVIV-------------------------------------------------------------------------------------
+>UniRef100_UPI00094622D5 60 0.286 2.495E-05 193 303 384 36 148 255
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GGFRVLDSACGTGMHTIELARR--GYAAAGADLSaKMIERARENAVSAGVAARFETAGfGQLQAAFGSEAFDVLLClgNSLPHVLSAAELAAALEDFAACLRPGGLLLVQNRNFD--------------------------------------------------------------------------------
+>UniRef100_A0A7W1SHZ7 59 0.329 3.310E-05 47 123 384 37 113 175
+-----------------------------------------------GDELGYYRALAEhGPTTPPELAERTGTDEHYAREWLNAQAAGSYV--TYDADSGRYTLPPEQAIALTDEtSPAFVVGLF--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A8I0C7G1 59 0.250 3.310E-05 196 297 384 116 242 289
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------SMLDLGVGSGAIILAILAERPNAKGLGIDVSeEALAVARDNAAHLGLGGRVALLRGDWTAGLSDESFDLVtanppyIATDVIETLEPEvrvheprlaldggpdgldAYRRLAPEILRVLKPGGLFFV--------------------------------------------------------------------------------------
+>UniRef100_A0A3M1L038 59 0.298 3.310E-05 193 267 384 118 194 290
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GARRILDVGTGCGAVAVALAVELPGAEIVATDVSEaVLEVAPANAERHGVSDRIEFRCGSLLEPlAAGERFDLIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A413QXR5 58 0.250 7.717E-05 192 276 384 114 205 286
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DSQAHILDIGTGSGAILLSVLHERPQCRGLGVDISqQALDVARKNGERLGLSDRVSWKISDLLASVPPAAYDWVVSNppyltaDDMHHLQPE-----------------------------------------------------------------------------------------------------------
+>UniRef100_UPI001F5CAA19 58 0.252 7.717E-05 197 297 384 117 242 289
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------VLDLGVGSGAILLAILAERPAAKGLGVDVSeEALAVARENAANLGLGGRVALLRGDWTAGLSDDSFDLVVSNppyiatDVIETLEPEvgvheprlaldggldglDAYRILaPEILRVLKPGGTFAV--------------------------------------------------------------------------------------
+>UniRef100_UPI0020C9A714 58 0.244 7.717E-05 196 297 384 116 242 289
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------SILDLGVGSGAIILSILAERPAAKGLGVDVSaEALAVARENAANLGMASRLALLRGDWTSGLGDASFDVVVSNppyiatDVLETLEPEvkdheprvaldggpdgldHYRRLAPEILRVLKPGGMFAV--------------------------------------------------------------------------------------
+>UniRef100_A0A6I3C5F3 57 0.275 1.357E-04 194 296 384 51 156 212
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PGRVLDAGCGTGRVARELARR--GVAVVGVDVDAvMLATARAKAPELQWIEH-DLASLDLARDptvnPPSSSFDVaVLAGNVMIFVTPGTEAAVLTRLASHVSPGGYVI---------------------------------------------------------------------------------------
+>UniRef100_A0A1V1PS24 57 0.333 1.357E-04 191 267 384 107 183 279
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PDDAARILDLGVGSGAILLAALRERPNAVGVGVDLSEaALEIAQANAEALGLRERVRLVQGD-WGAGLAEAFDVVVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_B4RGB7 57 0.248 1.357E-04 194 297 384 114 242 287
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PWSVLDLGVGSGAILLAILAERPAAKGLGIDASeEALAVARDNAAALGLAGRTALLRGDWTAGLGDSAFDLVVSnppyiaSDVLETLEPEvkdyeprlaleggadglDAYRILaPEIVRVLKPGGRFAV--------------------------------------------------------------------------------------
+>UniRef100_A0A1F9AMF8 57 0.325 1.357E-04 176 251 384 108 187 305
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LVEECLRLLRELSARQGPSAgrlRVLDLGTGCGTIALALAHAFPEAHYLATDLSaEALTLARENAERLGLSRRVTFRQGD------------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A2P2E901 57 0.333 1.357E-04 194 267 384 146 219 315
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PNRILDLGVGSGAILLALLAERPSWTGVGVDQSeEALELARENAALHGLSARLDLRQGD-WHHGIDERFDIVVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_UPI001653A8F6 57 0.250 1.798E-04 196 297 384 115 241 291
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------TMLDLGVGSGAILLAVLAERPAAKGLGVDVSeEALAVARENAANLGLADRAAFLRGDWTAGLGDESFDLVVSnppyirSAEIETLDPEvrdheprlaldggpdglDAYRLLaPEIMRVLKPGGVFAV--------------------------------------------------------------------------------------
+>UniRef100_A0A2V9FTA7 57 0.313 2.384E-04 265 364 384 1 99 100
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LLTNIFHRFDMATSEKLMRRVHAALKAGGKAITLEFVPNEDRITPPMAAAFSLTM---LAGTDSGDAYTFSQYEKMFRNAGFARTTEHAVPesPQQLLLLEK-------------------
+>UniRef100_UPI0022A7AF9B 57 0.307 2.384E-04 185 285 384 6 105 173
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------REQARAQAPWGAALDLGCGTGVHAVELARR--GWQVTGVDIvRKAIRRATKRARAAGVD--VRFLEGDITALPaqVGTGYRLILDFGAFHGLTDPERHALGRQV--------------------------------------------------------------------------------------------------
+>UniRef100_A0A348NQJ2 57 0.198 2.384E-04 194 297 384 112 242 282
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PKMILDLGTGSGALALAFANKYPEASVDAVDVSaEALSLAQENALALGLDNRVTFHEGSWWCPLGLGKqhYDLIVSNppyltneemttaepEVVDHEPHSalvsgadglgDMRLIFKDAASHMKPGGLLAL--------------------------------------------------------------------------------------
+>UniRef100_A0A1F4Q3A2 57 0.308 2.384E-04 192 267 384 113 193 291
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PQPPVILDLCTGTGAVAVALARELPAARIIATDISrRALRMARTNAERHGVADRVTFLRGDLWRAldghAPANGVDLVVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A2T4Z4G2 57 0.338 2.384E-04 192 255 384 118 182 303
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DRPLQVADLGCGSGAVAVTLAAERPHWQVIAVDLSPhALALARRNAEIHGVAERIQFRRGDWLQP--------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_UPI0021F9D48E 56 0.267 3.160E-04 199 267 384 117 187 284
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DLGTGSGILAVTLCVLFPGATGVAVDISPaALEVAKSNAQRHGVSGRIEFQHSDFTEQKFdPESFELVVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A7X7AW76 56 0.298 4.188E-04 196 297 384 69 168 283
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RVLDLACGPGLYTSRLARLGH--TCVGIDYSPaSIAHAEAEAEREDLACRYRLE--DLRSADYGSGFGLAmLLFGEFNAFRPVDARRILNTAHAALSEGGILLL--------------------------------------------------------------------------------------
+>UniRef100_A0A9E0MQ12 56 0.317 4.188E-04 184 267 384 107 191 289
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LDAVGGDRAAARRGLDLCTGSGVLAITLAHELPGLTMIATDVSaPAAAIARANAQRNRVEDRVEVRVGDRFAPVAGERFDVIVAN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A7X9FKT3 55 0.297 5.550E-04 180 252 384 103 175 286
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LIDMVREFFPE-DGRERFADLGTGSGCLAVTLAVRFPGWSGVAVDASPaALAVARENAARHGVSERIEFVPGDF-----------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_UPI001CD91C63 55 0.322 5.550E-04 176 267 384 104 194 288
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LVDTLLPALREAV-SQKGSARILDLGTGTGAICLALLKECPDATGIGSDISaGALETAAKNASRNGLETRFEIRQSDWFE-KISGSFDIIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_L0NLB7 55 0.315 7.356E-04 193 267 384 116 190 289
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GEARILDLGTGTGAIVLALLKECPQATGVGTDLSEaALQTARENAARLGLAGRFETIRSNWLE-EVTGRFDIVVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A2T0LHZ5 55 0.316 7.356E-04 192 267 384 123 201 302
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DRPLSVCDVGTGSGALAVTLAAERPRWSVWATDISPaALEVARDNARRNGVEGRIRFVRGEWLNPlrHRGVRVDVVVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A4P6H758 55 0.287 9.748E-04 184 267 384 107 192 290
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LPLLAEIGERKGRchVLDLGTGTGAIALALLAATPQARAVGVDISEdALTTAARNARDLGLSERFSAVRSDWFE-AISGRFDVIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A371XFG7 55 0.315 9.748E-04 196 267 384 121 192 294
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RILDLGTGTGAIALALLHEAPKAEAVGVDISdDALETANENARRLGLGNRFSTVKSSWFE-KIEGRFDVIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_UPI001FE0A581 54 0.293 1.292E-03 192 295 384 84 190 230
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DRPAEVLDLGCGNGVIAASVARRFGEAvRVAATDVSWlASDSARLTAAASGVE--VAVSQADGLESVADASLDLILTNPPFHRGTARDsapTLRMLAEAARVLRPGGQL----------------------------------------------------------------------------------------
+>UniRef100_A0A929D867 54 0.290 1.292E-03 193 303 384 33 161 269
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------EAHRVLDAACGTGMHSVALAQQ--GYAMTGTDLNaGMVERARANATAAGpVLSRAEGVDVQFEVAGFGElartltpalslpgrgsSFDAVLClgNSLPHLLTPASLAAALADFAACLRPGGLLLIQNRNFD--------------------------------------------------------------------------------
+>UniRef100_A0A546XUT9 54 0.329 1.292E-03 190 267 384 117 194 288
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------SQKGSARVLDLGTGTGAICLALLKECPGATGIGSDISaDALETAAKNASRNGLETRFEIRQSDWFE-KISGRFDIIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A546XBX9 54 0.303 1.711E-03 190 267 384 117 194 288
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------SHKGSARILDLGTGTGAICLALLKECPDATGIGSDIStGALETAAKNASRNGLETRFEIMQSDWFE-KISGRFDIIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A7X0SNC9 53 0.315 2.267E-03 184 255 384 114 186 304
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LLEAERWQGAELTALDVGTGSGALAVTLAAERPAWRVVASDLSPdALEVARGNARANGVEPRIAFVQGDLLEP--------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_UPI0004786EF2 53 0.304 2.267E-03 188 255 384 119 187 306
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GWGGGGALTALDVGTGSGALAVTLAAERPAWRVVASDLSPdALEVARGNARANGVAERVTFVRGDLLEP--------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A6N7IC32 53 0.301 3.004E-03 193 264 384 32 101 124
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PPGQALDVGCGEGADALWLARR--GWQVTAVDISRVA-LQRAATTGTSLAGRVAWTCADLTATPPPaGAFDLV-----------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A9D7HE84 53 0.324 3.004E-03 192 267 384 113 188 283
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------DAPHRILDLGTGSGAIMLALLKERPNATGVAIDISeEALAVVRANAEQLGVAERLQAGQGN-WAEHIDERFDLVVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A7V8DQQ7 53 0.303 3.004E-03 190 267 384 108 185 283
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------SPESAQTVLDLGTGTGAILLALLAERPNWTGLGIDIsSEALDLARENAKMHSLSERAHFQIGN-WAENITEKFNIVTSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A5B8B2L1 53 0.295 3.004E-03 174 267 384 95 191 286
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RPDTETLVEAVLPFVRRavqGKGACSILDLGTGTGAIALALLSAAPQAVATGVDISaDALATAARNAADLGLDGRFRTLQSDWFE-KISGRYDAIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_UPI000F83F048 53 0.313 3.004E-03 188 267 384 118 200 298
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LWPDTAALDVLDIGTGSGAIALTLAAERPRWRVTTVDLSPtALAIARENAQRLQVEYRVRFLEGDLAQPllAAGEQVDLLVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A0D8KML8 53 0.328 3.980E-03 193 267 384 121 195 289
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GSASVLDLGTGTGAICLALLKECPEATGIGSDISaDALETAAKNAARNGLASRFETVRSDWFK-KISGSFDIIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A7C2EBL1 53 0.302 3.980E-03 197 267 384 145 220 320
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------ILDLCTGTGAIAIALARELPAARLIATDISrRALRIARTNAEAHGVADRVRFLRGDLWRAlygvMPGRQADLIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A0B1TB99 52 0.310 5.272E-03 198 280 384 3 89 118
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------LDVGCGKGVHSALLANKFPKSNFTGIDvvMDAIQLANQQRKENGDSYENLKFEQMNgaKLDDNWSDKYDLVTIFFAAHDQTRPDLVR-------------------------------------------------------------------------------------------------------
+>UniRef100_UPI00227CA78F 52 0.369 5.272E-03 196 267 384 130 201 299
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RVIDLGTGTGAIGLTLLCELPQAEGTGTDISqDALATARRNAQRLGVSDRFRTICGNWF-DAVEGEYDLVVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_UPI00230011E8 52 0.293 5.272E-03 196 298 384 272 380 417
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------SIVDLGCGNGTISSYVPLKFKEFVGTMIatDSSRDAVAAtAETAKRNGVDSRVDVIRDDAMSTFAPASQDLILLNPPFHVgntVDPQIAPKLFRASARVLTQGGELWCV-------------------------------------------------------------------------------------
+>UniRef100_A0A257JKW7 52 0.320 6.983E-03 194 267 384 117 190 286
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PNRVLDLGVGSGTILLALLAERKSWTGVGIDLSqDALALATENAAHVDLTDRVEFRLGD-WHQGLDERFDIVVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A257HLL7 52 0.320 6.983E-03 194 267 384 117 190 286
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PNRVLDLGTGSGAILLALLAERKSWSGVGIDRSeEALALAADNAALHGLSDRVDLRLGD-WHQGLDEQFDIVVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A0N1A6W0 52 0.342 6.983E-03 196 267 384 122 193 290
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------SILDLGTGTGAIALALLHECGQAQAVGVDISEdALSTAARNAERLGLASRFETRAGPWF-VRVPERFDIIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A8D5UIE1 52 0.285 6.983E-03 194 255 384 118 180 297
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PIRVVDIGTGSGAIAVTLACERPHWEVWAIDLsPEALATAQTNAEIHGVRNRIVWRQGDLLEP--------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_H0UAL5 52 0.292 6.983E-03 189 267 384 120 201 299
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------WSAEQPLSVVDFGTGSGAITLTLAAEKPNWQLTTVDISlDAIAIAKQNAGRLDVEKRVRFIQGDLVEPilETGERVDIIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A4Q4CP92 51 0.307 9.249E-03 277 353 384 2 75 88
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------QKVALLRRAHAALPEGGALIVYDGMIDDDR----RENAFGLLMSLNMLIeTPGGFDYTGADCRGWMLQAGFREARVQP------------------------------
+>UniRef100_UPI001AE806D2 51 0.302 9.249E-03 193 267 384 116 190 287
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GEARLLDLGTGTGAIILALLKESPETQGIGSDISEdALKTAAENAARLGLSERFEAIRSDWFE-NISGRFDIIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_UPI001FF66CFB 51 0.263 9.249E-03 193 276 384 116 205 287
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GSARILDLGTGTGAIVLALLKESPQAQGIGSDISEdALQTASRNAARLGMSERFQAIRSDWF-DAISGRFDIIvsnppyICSGVIPALDPE-----------------------------------------------------------------------------------------------------------
+>UniRef100_A0A1I2LK27 51 0.320 9.249E-03 193 267 384 120 197 297
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RPLSVCDVGTGSGALAVTLAAERPRWVVFATDIsSAALAVARENARRNGVEERIRFLRGKWLEPlrQGGDRVDVVVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_UPI00115A3FED 51 0.315 1.225E-02 196 267 384 119 190 289
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RILDLGTGTGAILLALLKECPEATGLGADISaDALQTAQANAAALGLQDRFEAVRSDWF-QNIGQRFDMIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A502III3 51 0.292 1.225E-02 189 267 384 120 201 299
+---------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------WDTEQTLSVVDFGTGSGAITLTLAAEKPNWQLTTVDISlDAIAIATKNAERLGVRDRVRFLQGDLVEPMLiaGERVDILISN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A938SZY6 51 0.316 1.225E-02 197 255 384 128 187 299
+-----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------IVDIGTGSGCIAVALARALPTAVVYATDRSaGALQMARANAARQGVEDRIRFFAGDLFEP--------------------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A7C4LCS8 51 0.329 1.225E-02 180 267 384 119 209 302
+------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------VDEALKFLASTERAEAKVLDVGTGSGCIAVTLAVRRPRAAVTALDIaEDALDVARLNAERHGVAGRVAFFRSDLLEGlrLLRPGFDLVCAN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A920LUD8 51 0.315 1.622E-02 196 267 384 46 117 197
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------SCLDLGTGSGCLLLSLLSALPKTSGIGVDLaPLAVSQARANAAQLGLADRAQFICSDWFE-GVEGSFDLVLAN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A949NMS4 51 0.301 1.622E-02 196 267 384 109 180 278
+----------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------RIVDLGIGTGAIGLALLAECPEAQCLGVDVSaEAVAIALENARSLGLSARYSAVTGDWLS-GIEARFDLIVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_UPI000A19732A 51 0.333 1.622E-02 194 267 384 117 190 286
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PNRVLDLGTGSGAILLALLSERKSWTGVGIDRSeEALALAAENAALHGLSERVELRLGN-WHQGVDEEFDIVVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A7U4XWP3 51 0.333 1.622E-02 194 267 384 117 190 286
+--------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------PNRVLDLGVGSGTILLALLAERKSWTGVGIDRSeEALSLAGENASLHGLTDRVDLRLGD-WHQGLDEQFDIVVSN--------------------------------------------------------------------------------------------------------------------
+>UniRef100_A0A068SLK7 51 0.302 1.622E-02 193 267 384 116 190 287
+-------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------------GSARILDLGTGTGAIVLALLKESPQAQGIGSDISEdALQTALRNAARLGMSERFQAIRSDWF-DAISGRFDIIVSN--------------------------------------------------------------------------------------------------------------------
\ No newline at end of file
diff --git a/forks/boltz/examples/msa/seq2.a3m b/forks/boltz/examples/msa/seq2.a3m
new file mode 100644
index 00000000..ecaacc88
--- /dev/null
+++ b/forks/boltz/examples/msa/seq2.a3m
@@ -0,0 +1,168 @@
+>101
+SDQLEDSEVEAVAKGLEEXYANGVTEDNFKNYVKNNFAQQEISSVEEELNVNISDASTVVQARFNWNALGSCVANKIKDEFFAXISISAIVKAAQKKAWKELAVTVLRFAKANGLKTNAIIVAGQLALWAVQCGLS
+>UniRef100_A0A8S0JH07 200 0.549 9.920E-56 4 134 136 45 171 173
+----EQKQIDDVANVLEQMFRNGVNEKNFTEYVYKNFSQKDIAFAENELETNINNPY----DRVPWDEMGGCIAGKIRDEFFAMINVSLIVKYAQKKAWSELAKVVLRFVKANGLKTNIYIIAGQLAIWAVQCGM-
+>UniRef100_UPI00110EAFB6 199 0.977 2.558E-55 0 135 136 34 169 170
+SDQLEDSEVEAVAKGLEEMYTNGVTEDNFKNYVKNNFAQQEISSVEEELNVNISDASTVVQARFNWNALGSCVANKIKDEFFAMISISAIVKAAQKKAWKELAVTVLRFAKANGLKTNAIIVAGQLALWAVQCGLS
+>UniRef100_UPI001CF7A1DD 185 0.539 1.616E-50 9 134 136 1 122 124
+---------DDVANVLDQMFRNGVNEKNFTEYVYKNFSQKDIALAENKLETNINN----LYDRVPWDEMGGCIARKIREEFFAMTNVSLIVKYAQKKAWLELAKVVLRFVKANGLKTNTYIIAGQLAIWAVQCGL-
+>UniRef100_A0A455TWS1 177 0.686 8.943E-48 1 134 136 35 168 170
+-EQIKNSEVDTVAQGLEQMFSNGVSEENFKNYVNANFSSEEITKSEKELDVNLSNTSSPIQARVNWNGLGQCMANKIKDEFFAMINVGAIVAAAQKKAWKELAMTVLIFAKANGLKTNALIVAGQLAVWAVQCGL-
+>UniRef100_UPI0012B3E02F 177 0.466 8.943E-48 4 134 136 44 176 179
+----EQRQIDEVAAVLEKMFADGVTEENLKQYAQANYSEEELIIADNELNTNLSQIQDEnaIMYKVDWGALGNCMANKIKDELLAMISVGTIIKYAQKKAWKELAKIVIKYVAKAGVKTNAALIAGQLAIWGLQCGI-
+>UniRef100_A0A5Q2SBQ8 172 0.476 5.426E-46 9 134 136 1 128 131
+---------DEVAAVLEKMFADGVTEENLKQYAQANYSEEELIIADNELNTNLSQIQDEnaIMYKVDWGALGNCMANKIKDELLAMISVGTIIKYAQKKAWKELAKIVIKYVAKAGVKTNAALIAGQLAIWGLQCGI-
+>UniRef100_A0A7U9RNI7 166 0.503 6.190E-44 5 134 136 43 181 185
+-----DPEVAVVAQELEKIFANGVSQENLNKYVLKNFSNKELTVAEKELDVNYNpfslqskndNNSLHSVSVYGWNNLGQCMYNKIKDEFFEMVNIGVIVKYAKKKAWKELAKVVIRFAKGAGVRTNAAIVAAQLAVWAVQCGM-
+>UniRef100_UPI00062A1226 162 0.286 1.456E-42 10 134 136 55 183 186
+----------AVAKELEKMFVDGDIENLNIDYLIAKYGKDEIQATERFIGISENEsrifPTEHRIVQRDLADIGNCMLGKLGEEIRSMVNVNTIVAYIDKKLWLEAAKAIVAKVAAQGIKRNAAVMATVLAWYAVQCGL-
+>UniRef100_UPI0013568C51 162 0.445 2.738E-42 9 134 136 1 128 131
+---------DKFAAVLEKMFAKGVTEENFKQYAQANYSEEELMIADREMNTNLSqiQDDDVIMYKMDWNALGSYMANKIKDELLAMISIGTIITYAKRKAWKELATIVIKYVAKAWVRTNVAFIAGQLAIWGLQCGI-
+>UniRef100_UPI001FD87A89 159 0.533 1.821E-41 4 134 136 39 171 173
+----EDKEIELVANELEAMFSNGVTENNLKNYVNENYDSRDISTAEKELNTSLkkTNYNYLLRSKFSWNKFGNCMVNEIKDEFFAMINVATIVKYAKKKSWKKLAGVVLKFAKANGLKTNVAIIAGQLAVWAIKCGI-
+>UniRef100_UPI001A0EA69D 158 0.598 4.696E-41 3 134 136 44 173 175
+---ISSQEVDQVAQALELMFDNNVSTSNFKKYVNNNFSDSEIAIAELELESRISN--SRSEFRVAWNEMGGCIAGKIRDEFFAMISVGTIVKYAQKKAWKELALVVLKFVKANGLKTNAIIVAGQLALWAVQCGL-
+>UniRef100_UPI000DA36189 158 0.617 6.440E-41 7 134 136 48 173 175
+-------EVDQVAQALELMFDNNVSTSNFKKYVNNNFSDSEIAIAELELESRISN--SRSEFRVAWNEMGGCIAGKIRDEFFAMISVGTIVKYAQKKAWKELALVVLKFVKANGLKTNAIIVAGQLALWAVQCGL-
+>UniRef100_E1LSW0 157 0.518 1.211E-40 19 126 136 1 104 106
+-------------------FRNGVNEKNFTEYVYKNFSQKDIALAENELETNINNPY----DRVPWDEMGGCIAGKIREDFFAMTNVSLIVKYAQKRAWLELAKVVLRFVKANRLKTNIYIIAGQLA---------
+>UniRef100_A0A556UDB4 155 0.471 5.872E-40 0 134 136 34 173 177
+SDSVQSQDVDTVATELQKMFAHGVSQENLNKYAKENFSKQELQAASRELDVNYLANtssttYSPFISMFSWNSMGKCMYNKIKDELFAMVNVGVIVKYAKKKAWKELAKVVIRVAKGAGVKTNAILVAGQLAVWAVACGM-
+>UniRef100_A0A081PZB4 133 0.444 2.802E-32 4 93 136 75 160 161
+----EQKQIDDVANVLEQMFRNGVNEKNFTEYVYKNFSQKDIALSENELETNINNPY----DRVPWDEMGGCIAGKIRDEFFAMINVSLIVKYA------------------------------------------
+>UniRef100_K0Z545 115 0.231 4.125E-26 37 132 136 144 251 263
+-------------------------------------SSEQLALIVNSLNGAADNPYVDAQSDRSWGSFGSCVVTGVLGFSPFQIDYNLLGKYIYEKSWKKVADLLKRYAKKEIAKKSGNIVLKQiikstpagfaawLGVYAVGC---
+>UniRef100_UPI000D25C0E4 108 0.213 1.654E-23 23 132 136 90 210 222
+-----------------------VNEKLAAEYGFGR-SSEQLALIVNSLNGTSENPYVDAQSVRSWGSFGSCVVTGVLGFSPFQIDYNLLGKYIYEKSWNKVAGLLKRYAKKEIANKGGNIVLKQiikstpagfaawLGVYAVGC---
+>UniRef100_UPI001C8F0653 107 0.493 3.107E-23 57 129 136 23 95 100
+---------------------------------------------------------DVIMYKMDWNALGSYMANKIKDELLAMISIGTIITYAKRKAWKELATIVIKYVAKAWVRTNVAFIAGQLAIWG------
+>UniRef100_UPI000D52D7A3 103 0.210 5.309E-22 17 132 136 87 210 222
+-----------------KFFVD---EKLAAEYGFGR-SSEQLALIVNSLNGTSEHPHIDAQSVRSWGSFGSCVVTGVLGFSPFQIDYNLLGKYIYEKAWNKVAGLLKRYAKKEIAKKGGNIVLKQiikstpvgfaawLGVYAVGC---
+>UniRef100_A0A133S201 103 0.386 7.277E-22 19 93 136 1 71 72
+-------------------FRNGVNEKNFTECVYKNFSQKDIALAENKLETNINN----LYDRVPWDEMGGCIARKIREEFFAMTNVSLTVRYA------------------------------------------
+>UniRef100_UPI000B18BA61 97 0.666 8.234E-20 72 134 136 0 62 66
+------------------------------------------------------------------------MYNKIKDEFFAMVNIEVIVKYAKKKAWKELAKVVIRFAKGAGVRTNAAIVTAQLAVWAVQCGM-
+>UniRef100_UPI00207479F9 93 0.244 1.924E-18 1 132 136 16 154 158
+-EQIQDSqnQVDKVAKEFEDLFTNGiqINENSYainSDYLVQNYSSEEISGIVSLIEESSLINNTSTRSKRDIGSFLVCMKDKAVGDLKDMFNVGKFLVFIKTKAWKQAAEFAVKWLAKNGVKRNAVATAALLGWYGVQC---
+>UniRef100_A0A2N8LAA9 93 0.259 1.924E-18 3 132 136 36 170 174
+---ISQSEVDAVAIEFEKLFSNGIIisGNNYSinyDYLNNNYTSEEIQAFINLMASSELSPISSGRRKRSISSFVVCMKDKAVSDIADMFKVSAFVSFVQRKAWKEAAKFAVSWLAKNGIKRNVAATAALLSWYGIQC---
+>UniRef100_UPI001FF59259 88 0.233 8.429E-17 5 132 136 30 162 166
+-----QTEIESVASEFEQLFTKGIIisGNNYTfnhDYLTNNYTSDEIQAFIHLMDSTDLSPTFSKRRKRSIGSFAVCMKDKAVSDIADMFKVGAFVSFIQRKAWKEAAKFAVSWLAKNGIKRNVAATAALLSWYGIQC---
+>UniRef100_UPI000407185C 87 0.745 2.168E-16 84 134 136 1 51 53
+------------------------------------------------------------------------------------TNVSLIVKYAQKKAWSELAKVVLRFVKANGLKTNIYIIAGQLAIWAVQCGL-
+>UniRef100_UPI00135BC820 83 0.255 3.685E-15 5 132 136 38 170 174
+-----QAEVDAVAVELENLFTngiliNGDSYTLNIDYLYKNYTPEEVDSFIALMKSSNLSSNTINRKKRSVNSFLVCMKDKAVADIADMFKVGAFVSFIQRKAWREAAQFAVSWLARNGIKRNVAATAALLSWYGVQC---
+>UniRef100_A0A2N6UQ44 79 0.181 1.173E-13 3 132 136 47 200 206
+---ITEAEIDAFSQDVADKFVilmrdgiiyDGSSFRSNDDVLSAAGFANEADLIEElvdSLNKGANNRYTSVYTDRSLSSFGKCVVTGVLGFSPFQIDYNLLGKYIKEKAWNKVADLLQKYAKKEIEKKAGSVVLKQiikstpagfaawLGVYAVGC---
+>UniRef100_UPI001C0EBA32 79 0.168 1.607E-13 3 132 136 48 201 213
+---ITEAEIDAFSQEVADKFVilmrdgiiyDGSSFRSNDDVLSAmGFSNEAdlIKELVDSLNNGANNRYANVYTERSLSSFGKCVVTGVLGFSPFQIDYNLLGKYIKEKAWNKVADLLQKYAKKEIKKKAGSVVLKQiikstpagfaawLGVYAVGC---
+>UniRef100_UPI001C0F1009 78 0.162 4.127E-13 3 132 136 47 200 212
+---ITEAEIDAFSQEVADKFVilmrdgiiyDGSSFRSNDDVLSAmGFSNEAdlIKELVDSLNNGANNRYANVYTERSLSSFGKCVVTGVLGFSPFQIDYNLLGKYIKEKAWNKVADLLQKYAKKEIKKKAGSVLLKQiikstpagfaawLGVYAVGC---
+>UniRef100_UPI000214F415 66 0.346 2.716E-09 5 53 136 24 72 93
+-----DPEVAIAAQELEKIFVDVVSQKNLNRYALKNFSNKELTVAEKELDVNYN----------------------------------------------------------------------------------
+>UniRef100_UPI0012EE93E6 58 0.238 2.655E-06 62 124 136 108 170 202
+--------------------------------------------------------------DRSWASFGECVVTGILGFSIFGIDYNLLGQYIKQKAWGAAAALLKKEAEKELKKQGAKIALKQ-----------
+>UniRef100_UPI0011BE0601 57 0.141 6.774E-06 3 96 136 48 153 158
+---ITEAEIDAFSQEVADKFVilmrdgiiyDGSSFRSNDDVLSAmGFSNgaDLIKELVDSLNNGANNRYANVYTERSWSSFGKCVVTGVLGFSPFQIDYNLLGKYIKEK---------------------------------------
+>UniRef100_UPI000370F184 55 0.201 2.359E-05 29 132 136 98 206 211
+-----------------------------KEVLISNLGYDEASATAESLGLTIDELVSDRTVpntngDRGVGEFLSCMKGHATDDLKSIFNVNAVSYYIGKEKYFEAALAAGKHLAKQGIRRNAYGLIGILAWYGVRC---
+>UniRef100_A0A0G3H5S3 55 0.206 3.222E-05 4 132 136 51 180 185
+----QEEQVEALA-ELLKEMDEAGSEAEVQQLFVERFGQDNLEDAAAQLGTNTSEVFreSDEVVEEGFGEFLQCIKGKATNDIKKALDVNVVAAFIGQKDYAKAAWAIVKHLAKQGIKRNAFAIAGMLAWWAWQC---
+>UniRef100_UPI000F652D05 50 0.250 9.887E-04 63 134 136 111 182 185
+---------------------------------------------------------------RDTGEFLSCMKGKASDDLKSIFDVNAIAVLIGQEKYGEAAVAAVKYLAKQGIKRNAAGIAGVLLFYAAKCSI-
+>UniRef100_UPI00125CB70C 46 0.225 2.995E-02 53 132 136 97 176 181
+-----------------------------------------------------NELTTDTTSFRGAPQFLSCMKSKVSNDLKSIFNINAIASLIGQQKYYEAAVKAVQYLAKQGIKRNVAGIAGALAFYGAKC---
+>UniRef100_UPI0009761044 44 0.285 1.404E-01 67 132 136 108 174 176
+-------------------------------------------------------------------SFWSCMKNQLLDmigyQTFQALLRGGIQGLIQRKAWKAAAKLLIRYL---GDGIGVGFIAAQLAWYAIRC---
+>UniRef100_V9W2Y6 44 0.311 1.911E-01 72 132 136 0 56 60
+------------------------------------------------------------------------MKDKLMQEFEELVNIGTLGVLIAEKKWTELAWTLIKK----GVKRNPWVLAGWLAWQAAKC---
+>UniRef100_UPI001F1C6CF6 43 0.252 3.541E-01 70 132 136 53 115 120
+----------------------------------------------------------------------SCMEGKVEDDVKEIFHVNAIAVLIGQEKYFEAAEEAVAYLAKQGVKRNAAAIASVLAFYGARC---
+>UniRef100_UPI001F2B8987 43 0.252 3.541E-01 70 132 136 116 178 183
+----------------------------------------------------------------------SCMEGKVEDDVKEIFHVNAIAVLIGQEKYFEAAEEAVAYLAKQGVKRNAAAIASVLAFYGARC---
+>UniRef100_A0A2S0WEI1 42 0.228 4.819E-01 63 132 136 52 121 129
+---------------------------------------------------------------RSVGEFLTCMRSEVTDDLKSIFDINAIAALIGREKYWEAAVEAVKFLAKQGIKRNVAGLAATLAFYGGKC---
+>UniRef100_A0A9D1RZL8 39 0.238 5.627E+00 66 132 136 112 178 183
+------------------------------------------------------------------GEFLSCIKGKVDAEVKAIFDVNAIAVLIGQENYFKAAKKAVDFLARQGIRKNAVGIAAVLAYHGARC---
+>101
+SDQLEDSEVEAVAKGLEEXYANGVTEDNFKNYVKNNFAQQEISSVEEELNVNISDASTVVQARFNWNALGSCVANKIKDEFFAXISISAIVKAAQKKAWKELAVTVLRFAKANGLKTNAIIVAGQLALWAVQCGLS
+>U6S4W9 158 0.985 3.319E-41 0 135 136 55 190 191
+SDQLEDSEVEAVAKGLEEMYANGVTEDNFKNYVKNNFAQQEISSVEEELNVNISDASTVVQARFNWNALGSCVANKIKDEFFAMISISAIVKAAQKKAWKELAVTVLRFAKANGLKTNAIIVAGQLALWAVQCGLS
+>uvig_117295_3 158 0.985 3.319E-41 0 135 136 55 190 191
+SDQLEDSEVEAVAKGLEEMYANGVTEDNFKNYVKNNFAQQEISSVEEELNVNISDASTVVQARFNWNALGSCVANKIKDEFFAMISISAIVKAAQKKAWKELAVTVLRFAKANGLKTNAIIVAGQLALWAVQCGLS
+>A0A1C0USB4 156 0.557 1.610E-40 4 134 136 45 171 173
+----EQKQIDDVANVLEQMFRNGVNEKNFTEYVYKNFSQKDIALAENELETNINNPYD----RVPWDEMGGCIAGKIRDEFFAMINVSLIVKYAQKKAWSELAKVVLRFVKANGLKTNIYIIAGQLAIWAVQCGL-
+>MGYP000967978327 156 0.557 1.610E-40 4 134 136 45 171 173
+----EQKQIDDVANVLEQMFRNGVNEKNFTEYVYKNFSQKDIALAENELETNINNPYD----RVPWDEMGGCIAGKIRDEFFAMINVSLIVKYAQKKAWSELAKVVLRFVKANGLKTNIYIIAGQLAIWAVQCGL-
+>R2N7C7 143 0.686 7.398E-36 1 134 136 35 168 170
+-EQIKNSEVDTVAQGLEQMFSNGVSEENFKNYVNANFSSEEITKSEKELDVNLSNTSSPIQARVNWNGLGQCMANKIKDEFFAMINVGAIVAAAQKKAWKELAMTVLIFAKANGLKTNALIVAGQLAVWAVQCGL-
+>A0A2A5L654 137 0.286 1.156E-33 10 134 136 55 183 186
+----------AVAKELEKMFVDGDIENLNIDYLIAKYGKDEIQATERFIGISENEsrifPTEHRIVQRDLADIGNCMLGKLGEEIRSMVNVNTIVAYIDKKLWLEAAKAIVAKVAAQGIKRNAAVMATVLAWYAVQCGL-
+>3300014513.a:Ga0169742_10090_9 137 0.286 1.156E-33 10 134 136 55 183 187
+----------AVAKELEKMFVDGDIENLNIDYLIAKYGKDEIQATERFIGISENEsrifPTEHRIVQRDLADIGNCMLGKLGEEIRSMVNVNTIVAYIDKKLWLEAAKAIVAKVAAQGIKRNAAVMATVLAWYAVQCGL-
+>A0A256LDH3 134 0.503 1.053E-32 5 134 136 43 181 185
+-----DPEVAVVAQELEKIFANGVSQENLNRYVLKNFSNKELTVAEKELDVNYN--PFSLQSKNDnnslhsvsvygWNNLGQCMYNKIKDEFFAMVNIGVIVKYAKKKAWKELAKVVIRFAKGAGVRTNAAIVAAQLAVWAVQCGM-
+>Q6DRR6 128 0.466 8.748E-31 4 134 136 44 176 179
+----EQRQIDEVAAVLEKMFADGVTEENLKQYAQANYSEEELIIADNELNTNLSQIQDenAIMYKVDWGALGNCMANKIKDELLAMISVGTIIKYAQKKAWKELAKIVIKYVAKAGVKTNAALIAGQLAIWGLQCGI-
+>MGYP000869820508 128 0.237 1.199E-30 4 133 136 55 192 196
+----EEQQVEEVAKLLEKM-DKAPSREEAQRVLEDNFSQEELNGVAEELDIssdevltgaDAKDVGDAAATEEGFKDFYRCIKSKAGKDLRSALNVNAVMAAFGQKDYLKAAREIVKYLLKNGLKRNVFALAVTLGWYALQCS--
+>MGYP000215453753 126 0.222 5.813E-30 4 132 136 51 184 188
+----EKQQVEQLAKVLEKV-DNAPNREEAERIMVENFGEEGLEEAAKEIGVDPNNplgegsPTRSARGEVNEEGFVECMAGKVGDEIKGLLNINGVALALGQKDYPKMAAEIVKYLAKQGIKRNVGALALLLAWYGAQC---
+>A0A0T8EFX5 116 0.504 2.127E-26 19 127 136 1 105 106
+-------------------FRNGVNEKNFTEYVYKNFSQKDIALAENELETNINNPYD----RVPWDEMGGCIVGKIREDFFAMTNVSLIVKYAQKRAWLELAKVVLRFVKANRLKTNIYIIAGQLAF--------
+>MGYP000013645973 116 0.244 2.127E-26 1 132 136 16 154 158
+-EQIQDSqnQVDKVAKEFEDLFTNGiqINENSYainSDYLVQNYSSEEISGIVSLIEEISLINNTYTRSKRDIGSFLVCMKDKAVGDLKDMFNVGKFLVFIKTKAWKQAAEFAVKWLAKNGVKRNAVATAALLGWYGVQC---
+>MGYP000875481199 113 0.232 1.936E-25 4 132 136 52 192 197
+----EEQQVEEIAKFLEQV-DKAPSEKDAHRILEERFSQEELNGAAEELGVSPEEmfadggaqdgaklPEDPANNEESFGSFMRCIAGKAGNDLKSVIYSKDVLRAISKKQYKKAALAIVRHLAKQGIKRNIVVLGIQLGWYAFQC---
+>MGYP000964187490 103 0.221 5.146E-22 5 103 136 30 133 134
+-----QTEIESVASEFEQLFTKGIIisGNNYTfnhDYLTNNYTSDEIQAFIHLMDSTDLSPTFSKRRKRSIGSFAVCMKDKAVSDIADMFKVGAFVSFVQRKAWKEAAK--------------------------------
+>A0A0K0G7I1 94 0.202 7.246E-19 0 132 136 10 172 176
+SDDVEGAELAKLEQDLEFLFEEATTEEGDKYVLdeekaKDYFGEEnlpEIKILIKLINeeevteeefLNagiVPKHESYEEAKaevRDQNdnlvsnySWLGCMKTKIIAGTGLGFFGKGIDKLIEDKNWKKLSKEIIKIVGKNAVRGGAVGLAASLAVWSTMC---
+>W7RBR4 91 0.250 1.235E-17 61 132 136 114 185 189
+-------------------------------------------------------------SQFHTASWWGCLKEKIIDFTGLGFIGGGLEKMLKKKLWKKAATEIIKIVGKNAIRGGVLGLAGSLAWFSVRC---
+>MGYP001084790427 85 0.971 1.389E-15 67 135 136 9 77 78
+-------------------------------------------------------------------SLGSCVANKIKDEFFAMISISAIVKAAQKKAWKELAVTVLRFAKANGLKTNAIIVAGQLALWAVQCGLS
+>MGYP001008199351 84 0.710 1.903E-15 66 134 136 15 83 85
+------------------------------------------------------------------DEMGGCIAGKIRDEFFAMINVSLIVKYAQKKAWSELAKVVLRFVKANGLKTNIYIIAGQLAIWAVQCGL-
+>MGYP001068281740 75 0.984 3.611E-12 0 63 136 34 97 115
+SDQLEDSEVEAVAKGLEEMYANGVTEDNFKNYVKNNFAQQEISSVEEELNVNISDASTVVQARF------------------------------------------------------------------------
+>MGYP000904613324 74 0.242 4.944E-12 67 132 136 14 79 83
+-------------------------------------------------------------------SWTSCIKEKIMIATGIGFITGGMNKLIEEKAWKKLSLEIAKIVGKNAIKGGVVGLTASLAVWSIVC---
+>MGYP000968663296 70 0.396 1.143E-10 4 56 136 64 116 117
+----EQKQIDDVANVLEQMFRNGVNEKNFTEYVYKNFSQKDIALAENKLETNINNLY-------------------------------------------------------------------------------
+>A0A133S201 70 0.378 2.141E-10 19 92 136 1 70 72
+-------------------FRNGVNEKNFTECVYKNFSQKDIALAENKLETNINNLYD----RVPWDEMGGCIARKIREEFFAMTNVSLTVRY-------------------------------------------
+>MGYP001149482190 69 0.678 4.009E-10 79 134 136 22 77 81
+-------------------------------------------------------------------------------EFFAMVNIGLIVKYAKKKAWKELAKVVIRFAKGAGVRTNAAIVAAQLAVWAVQCGM-
+>A0A0Q9UUB0 68 0.270 1.027E-09 38 132 136 83 175 203
+--------------------------------------QQEIESSSCELaETTVINPIQPLAAKKSWKS---CMVASLKDHFGVALIevamTGGLWAYLQKKAYKEAAKLLIKI----GIGGNAIGLAATLTWYGTRC---
+>A0A192YJB0 67 0.271 1.406E-09 67 132 136 117 183 185
+-------------------------------------------------------------------SFWSCMKNQLLDmisyQTFQALLRGGIQGLIQRKAWKAAAKLLIRYLG-DGI--GVGFIAAQLSWYAIRC---
+>MGYP000655452331 66 0.928 2.632E-09 80 135 136 7 62 63
+--------------------------------------------------------------------------------IRDRISISAIVKAAQKKAWKELAVTVLRFAKANGLKTNAIIVAGQLALWAVQCGLS
+>R8G7N7 62 0.238 8.256E-08 8 132 136 43 187 190
+--------VEKLAEDLEFIMEKAAIRNsNDKVIdfdfdkLENRFGKlQEFKILKNEINndklnkheinqkqcTNISN-YNSLQAK-SWNGWKSCMVDALKDHFGVKIieiaFEGGLWGYLEKKAYKEAAKLLVKI----AVGSNVLGVTSFLVYYGAKC---
+>UniRef100_A0A1X7GMK4 61 0.216 1.544E-07 7 132 136 38 178 206
+-------QVDELAEDLEFLMEEAaiyDSENNVVgfhfDKLEDRFGeveelkmlQQEIESSSCELvetTTTETNSVQPLAAKKTWK---GCMIDSLKDHFGVAIIevamTGGLWAYLEQKAYKEAAKLLIKI----GVGGNVIGLAAFLTYYSAKC---
+>A0A1X7GMK4 61 0.216 1.544E-07 7 132 136 38 178 206
+-------QVDELAEDLEFLMEEAaiyDSENNVVgfhfDKLEDRFGeveelkmlQQEIESSSCELvetTTTETNSVQPLAAKKTWK---GCMIDSLKDHFGVAIIevamTGGLWAYLEQKAYKEAAKLLIKI----GVGGNVIGLAAFLTYYSAKC---
+>MGYP001088613770 60 0.318 3.946E-07 5 70 136 29 92 98
+-----DPEVAVAAQELEKIFVDAVSQKNLNRYALKNFSNKELTVAEKELDVNYN--PFSLQSKNDNNSLHS-----------------------------------------------------------------
+>A0A1L6ZGN2 59 0.239 7.374E-07 66 132 136 107 173 182
+------------------------------------------------------------------GTWGDCMIDSLKDHFGVAMIevalTGGLWSYLEKKAYKEAAKLLLKI----GIGGNVIGLVAFLTWYSAKC---
+>A0A1J9VKJ1 55 0.252 1.674E-05 62 132 136 108 176 182
+--------------------------------------------------------------KRS--AWTDCMVDAIKDHFGVAAVTaaleGGLWAYLEKKAYKEAAKLLVKF----AIGSNAVGLAGTLVYYGGKC---
+>F7SG70 55 0.318 3.123E-05 5 70 136 24 87 93
+-----DPEVAIAAQELEKIFVDVVSQKNLNRYALKNFSNKELTVAEKELDVNYN--PFSLQLKNDNNSLHS-----------------------------------------------------------------
+>A0A0V8JI20 51 0.273 5.147E-04 64 132 136 107 175 181
+----------------------------------------------------------------SNEAWKSCMIGAIKDHFGVAMVTaaleGGLWAYLEKKAYKEAAKLLVKF----AVGSNAVGLAGTLIYYGGVC---
+>MGYP000101651737 46 0.236 2.903E-02 15 69 136 9 58 59
+---------------LEQEFLISLI-KDKPETVYKNFSKKDIALAENKLEININNLYD----RVPWDEMG------------------------------------------------------------------
+>A0A270AIV9 44 0.276 9.993E-02 86 132 136 1 43 71
+--------------------------------------------------------------------------------------TGGLWANLEKKAYKEAAKLLVKI----GIGGNAIDLASFLTWYSARC---
+>MGYP001000650989 44 0.276 1.853E-01 86 132 136 18 60 67
+--------------------------------------------------------------------------------------TGGLWGYLKKKAYKEAAKLLVKI----GVGTNAATLAATLIYYGGKC---
+>MGYP001053269802 44 0.216 1.853E-01 68 133 136 0 82 88
+--------------------------------------------------------------------FGKCILNKMdlgeLKNLAKIIFKPATVRYLKSHAWKKASammvNAIVQYAPKKvaslAVKKFANLTLpgvgwASVAWWGAQCG--
+>MGYP000578092484 42 0.315 8.644E-01 63 132 136 95 167 172
+---------------------------------------------------------------RSPYDFGKCI---LKDYFGVYIDlvqgklWDSFVGYLQSEAWTEAAKIILKIIGKSASKANLIATAGQLALAAFNC---
diff --git a/forks/boltz/examples/multimer.yaml b/forks/boltz/examples/multimer.yaml
new file mode 100644
index 00000000..c314c48b
--- /dev/null
+++ b/forks/boltz/examples/multimer.yaml
@@ -0,0 +1,8 @@
+version: 1 # Optional, defaults to 1
+sequences:
+ - protein:
+ id: A
+ sequence: MAHHHHHHVAVDAVSFTLLQDQLQSVLDTLSEREAGVVRLRFGLTDGQPRTLDEIGQVYGVTRERIRQIESKTMSKLRHPSRSQVLRDYLDGSSGSGTPEERLLRAIFGEKA
+ - protein:
+ id: B
+ sequence: MRYAFAAEATTCNAFWRNVDMTVTALYEVPLGVCTQDPDRWTTTPDDEAKTLCRACPRRWLCARDAVESAGAEGLWAGVVIPESGRARAFALGQLRSLAERNGYPVRDHRVSAQSA
diff --git a/forks/boltz/examples/pocket.yaml b/forks/boltz/examples/pocket.yaml
new file mode 100644
index 00000000..96936237
--- /dev/null
+++ b/forks/boltz/examples/pocket.yaml
@@ -0,0 +1,12 @@
+sequences:
+ - protein:
+ id: [A1]
+ sequence: MYNMRRLSLSPTFSMGFHLLVTVSLLFSHVDHVIAETEMEGEGNETGECTGSYYCKKGVILPIWEPQDPSFGDKIARATVYFVAMVYMFLGVSIIADRFMSSIEVITSQEKEITIKKPNGETTKTTVRIWNETVSNLTLMALGSSAPEILLSVIEVCGHNFTAGDLGPSTIVGSAAFNMFIIIALCVYVVPDGETRKIKHLRVFFVTAAWSIFAYTWLYIILSVISPGVVEVWEGLLTFFFFPICVVFAWVADRRLLFYKYVYKRYRAGKQRGMIIEHEGDRPSSKTEIEMDGKVVNSHVENFLDGALVLEVDERDQDDEEARREMARILKELKQKHPDKEIEQLIELANYQVLSQQQKSRAFYRIQATRLMTGAGNILKRHAADQARKAVSMHEVNTEVTENDPVSKIFFEQGTYQCLENCGTVALTIIRRGGDLTNTVFVDFRTEDGTANAGSDYEFTEGTVVFKPGDTQKEIRVGIIDDDIFEEDENFLVHLSNVKVSSEASEDGILEANHVSTLACLGSPSTATVTIFDDDHAGIFTFEEPVTHVSESIGIMEVKVLRTSGARGNVIVPYKTIEGTARGGGEDFEDTCGELEFQNDEIVKIITIRIFDREEYEKECSFSLVLEEPKWIRRGMKGGFTITDEYDDKQPLTSKEEEERRIAEMGRPILGEHTKLEVIIEESYEFKSTVDKLIKKTNLALVVGTNSWREQFIEAITVSAGEDDDDDECGEEKLPSCFDYVMHFLTVFWKVLFAFVPPTEYWNGWACFIVSILMIGLLTAFIGDLASHFGCTIGLKDSVTAVVFVALGTSVPDTFASKVAATQDQYADASIGNVTGSNAVNVFLGIGVAWSIAAIYHAANGEQFKVSPGTLAFSVTLFTIFAFINVGVLLYRRRPEIGGELGGPRTAKLLTSCLFVLLWLLYIFFSSLEAYCHIKGF
+ - ligand:
+ ccd: EKY
+ id: [B1]
+constraints:
+ - pocket:
+ binder: B1
+ contacts: [ [ A1, 829 ], [ A1, 138 ] ]
+
diff --git a/forks/boltz/examples/prot.fasta b/forks/boltz/examples/prot.fasta
new file mode 100644
index 00000000..92a26192
--- /dev/null
+++ b/forks/boltz/examples/prot.fasta
@@ -0,0 +1,2 @@
+>A|protein|./examples/msa/seq2.a3m
+QLEDSEVEAVAKGLEEMYANGVTEDNFKNYVKNNFAQQEISSVEEELNVNISDSCVANKIKDEFFAMISISAIVKAAQKKAWKELAVTVLRFAKANGLKTNAIIVAGQLALWAVQCG
\ No newline at end of file
diff --git a/forks/boltz/examples/prot.yaml b/forks/boltz/examples/prot.yaml
new file mode 100644
index 00000000..20ae735e
--- /dev/null
+++ b/forks/boltz/examples/prot.yaml
@@ -0,0 +1,6 @@
+version: 1 # Optional, defaults to 1
+sequences:
+ - protein:
+ id: A
+ sequence: QLEDSEVEAVAKGLEEMYANGVTEDNFKNYVKNNFAQQEISSVEEELNVNISDSCVANKIKDEFFAMISISAIVKAAQKKAWKELAVTVLRFAKANGLKTNAIIVAGQLALWAVQCG
+
diff --git a/forks/boltz/examples/prot_custom_msa.yaml b/forks/boltz/examples/prot_custom_msa.yaml
new file mode 100644
index 00000000..5cde5ad2
--- /dev/null
+++ b/forks/boltz/examples/prot_custom_msa.yaml
@@ -0,0 +1,7 @@
+version: 1 # Optional, defaults to 1
+sequences:
+ - protein:
+ id: A
+ sequence: QLEDSEVEAVAKGLEEMYANGVTEDNFKNYVKNNFAQQEISSVEEELNVNISDSCVANKIKDEFFAMISISAIVKAAQKKAWKELAVTVLRFAKANGLKTNAIIVAGQLALWAVQCG
+ msa: ./examples/msa/seq2.a3m
+
diff --git a/forks/boltz/examples/prot_no_msa.yaml b/forks/boltz/examples/prot_no_msa.yaml
new file mode 100644
index 00000000..f9889b91
--- /dev/null
+++ b/forks/boltz/examples/prot_no_msa.yaml
@@ -0,0 +1,6 @@
+version: 1 # Optional, defaults to 1
+sequences:
+ - protein:
+ id: A
+ sequence: QLEDSEVEAVAKGLEEMYANGVTEDNFKNYVKNNFAQQEISSVEEELNVNISDSCVANKIKDEFFAMISISAIVKAAQKKAWKELAVTVLRFAKANGLKTNAIIVAGQLALWAVQCG
+ msa: empty
diff --git a/forks/boltz/pyproject.toml b/forks/boltz/pyproject.toml
new file mode 100644
index 00000000..9e22f29e
--- /dev/null
+++ b/forks/boltz/pyproject.toml
@@ -0,0 +1,94 @@
+[build-system]
+requires = ["setuptools >= 61.0"]
+build-backend = "setuptools.build_meta"
+
+[project]
+name = "boltz"
+version = "2.2.0"
+requires-python = ">=3.10,<3.13"
+description = "Boltz"
+readme = "README.md"
+dependencies = [
+ "torch>=2.2",
+ "numpy>=1.26,<2.0",
+ "hydra-core==1.3.2",
+ "pytorch-lightning==2.5.0",
+ "rdkit>=2024.3.2",
+ "dm-tree==0.1.8",
+ "requests==2.32.3",
+ "pandas>=2.2.2",
+ "types-requests",
+ "einops==0.8.0",
+ "einx==0.3.0",
+ "fairscale==0.4.13",
+ "mashumaro==3.14",
+ "modelcif==1.2",
+ "wandb==0.18.7",
+ "click==8.1.7",
+ "pyyaml==6.0.2",
+ "biopython==1.84",
+ "scipy==1.13.1",
+ "numba==0.61.0",
+ "gemmi==0.6.5",
+ "scikit-learn==1.6.1",
+ "chembl_structure_pipeline==1.2.2",
+]
+
+[project.scripts]
+boltz = "boltz.main:cli"
+
+[project.optional-dependencies]
+lint = ["ruff"]
+test = ["pytest", "requests"]
+cuda = [
+ "cuequivariance_ops_cu12>=0.5.0",
+ "cuequivariance_ops_torch_cu12>=0.5.0",
+ "cuequivariance_torch>=0.5.0",
+]
+
+[tool.ruff]
+src = ["src"]
+extend-exclude = ["conf.py"]
+target-version = "py39"
+lint.select = ["ALL"]
+lint.ignore = [
+ "COM812", # Conflicts with the formatter
+ "ISC001", # Conflicts with the formatter
+ "ANN101", # "missing-type-self"
+ "RET504", # Unnecessary assignment to `x` before `return` statementRuff
+ "S101", # Use of `assert` detected
+ "D100", # Missing docstring in public module
+ "D104", # Missing docstring in public package
+ "PT001", # https://github.com/astral-sh/ruff/issues/8796#issuecomment-1825907715
+ "PT004", # https://github.com/astral-sh/ruff/issues/8796#issuecomment-1825907715
+ "PT005", # https://github.com/astral-sh/ruff/issues/8796#issuecomment-1825907715
+ "PT023", # https://github.com/astral-sh/ruff/issues/8796#issuecomment-1825907715
+ "FBT001",
+ "FBT002",
+ "PLR0913", # Too many arguments to init (> 5)
+]
+
+[tool.ruff.lint.per-file-ignores]
+"**/__init__.py" = [
+ "F401", # Imported but unused
+ "F403", # Wildcard imports
+]
+"docs/**" = [
+ "INP001", # Requires __init__.py but folder is not a package.
+]
+"scripts/**" = [
+ "INP001", # Requires __init__.py but folder is not a package.
+]
+
+[tool.ruff.lint.pyupgrade]
+# Preserve types, even if a file imports `from __future__ import annotations`(https://github.com/astral-sh/ruff/issues/5434)
+keep-runtime-typing = true
+
+[tool.ruff.lint.pydocstyle]
+convention = "numpy"
+
+[tool.pytest.ini_options]
+markers = [
+ "slow: marks tests as slow (deselect with '-m \"not slow\"')",
+ "regression",
+]
diff --git a/forks/boltz/scripts/eval/aggregate_evals.py b/forks/boltz/scripts/eval/aggregate_evals.py
new file mode 100644
index 00000000..81ea980c
--- /dev/null
+++ b/forks/boltz/scripts/eval/aggregate_evals.py
@@ -0,0 +1,753 @@
+import json
+from pathlib import Path
+
+import matplotlib.pyplot as plt
+import numpy as np
+import pandas as pd
+from tqdm import tqdm
+
+METRICS = ["lddt", "bb_lddt", "tm_score", "rmsd"]
+
+
+def compute_af3_metrics(preds, evals, name):
+ metrics = {}
+
+ top_model = None
+ top_confidence = -1000
+ for model_id in range(5):
+ # Load confidence file
+ confidence_file = (
+ Path(preds) / f"seed-1_sample-{model_id}" / "summary_confidences.json"
+ )
+ with confidence_file.open("r") as f:
+ confidence_data = json.load(f)
+ confidence = confidence_data["ranking_score"]
+ if confidence > top_confidence:
+ top_model = model_id
+ top_confidence = confidence
+
+ # Load eval file
+ eval_file = Path(evals) / f"{name}_model_{model_id}.json"
+ with eval_file.open("r") as f:
+ eval_data = json.load(f)
+ for metric_name in METRICS:
+ if metric_name in eval_data:
+ metrics.setdefault(metric_name, []).append(eval_data[metric_name])
+
+ if "dockq" in eval_data and eval_data["dockq"] is not None:
+ metrics.setdefault("dockq_>0.23", []).append(
+ np.mean(
+ [float(v > 0.23) for v in eval_data["dockq"] if v is not None]
+ )
+ )
+ metrics.setdefault("dockq_>0.49", []).append(
+ np.mean(
+ [float(v > 0.49) for v in eval_data["dockq"] if v is not None]
+ )
+ )
+ metrics.setdefault("len_dockq_", []).append(
+ len([v for v in eval_data["dockq"] if v is not None])
+ )
+
+ eval_file = Path(evals) / f"{name}_model_{model_id}_ligand.json"
+ with eval_file.open("r") as f:
+ eval_data = json.load(f)
+ if "lddt_pli" in eval_data:
+ lddt_plis = [
+ x["score"] for x in eval_data["lddt_pli"]["assigned_scores"]
+ ]
+ for _ in eval_data["lddt_pli"][
+ "model_ligand_unassigned_reason"
+ ].items():
+ lddt_plis.append(0)
+ if not lddt_plis:
+ continue
+ lddt_pli = np.mean([x for x in lddt_plis])
+ metrics.setdefault("lddt_pli", []).append(lddt_pli)
+ metrics.setdefault("len_lddt_pli", []).append(len(lddt_plis))
+
+ if "rmsd" in eval_data:
+ rmsds = [x["score"] for x in eval_data["rmsd"]["assigned_scores"]]
+ for _ in eval_data["rmsd"]["model_ligand_unassigned_reason"].items():
+ rmsds.append(100)
+ if not rmsds:
+ continue
+ rmsd2 = np.mean([x < 2.0 for x in rmsds])
+ rmsd5 = np.mean([x < 5.0 for x in rmsds])
+ metrics.setdefault("rmsd<2", []).append(rmsd2)
+ metrics.setdefault("rmsd<5", []).append(rmsd5)
+ metrics.setdefault("len_rmsd", []).append(len(rmsds))
+
+ # Get oracle
+ oracle = {k: min(v) if k == "rmsd" else max(v) for k, v in metrics.items()}
+ avg = {k: sum(v) / len(v) for k, v in metrics.items()}
+ top1 = {k: v[top_model] for k, v in metrics.items()}
+
+ results = {}
+ for metric_name in metrics:
+ if metric_name.startswith("len_"):
+ continue
+ if metric_name == "lddt_pli":
+ l = metrics["len_lddt_pli"][0]
+ elif metric_name == "rmsd<2" or metric_name == "rmsd<5":
+ l = metrics["len_rmsd"][0]
+ elif metric_name == "dockq_>0.23" or metric_name == "dockq_>0.49":
+ l = metrics["len_dockq_"][0]
+ else:
+ l = 1
+ results[metric_name] = {
+ "oracle": oracle[metric_name],
+ "average": avg[metric_name],
+ "top1": top1[metric_name],
+ "len": l,
+ }
+
+ return results
+
+
+def compute_chai_metrics(preds, evals, name):
+ metrics = {}
+
+ top_model = None
+ top_confidence = 0
+ for model_id in range(5):
+ # Load confidence file
+ confidence_file = Path(preds) / f"scores.model_idx_{model_id}.npz"
+ confidence_data = np.load(confidence_file)
+ confidence = confidence_data["aggregate_score"].item()
+ if confidence > top_confidence:
+ top_model = model_id
+ top_confidence = confidence
+
+ # Load eval file
+ eval_file = Path(evals) / f"{name}_model_{model_id}.json"
+ with eval_file.open("r") as f:
+ eval_data = json.load(f)
+ for metric_name in METRICS:
+ if metric_name in eval_data:
+ metrics.setdefault(metric_name, []).append(eval_data[metric_name])
+
+ if "dockq" in eval_data and eval_data["dockq"] is not None:
+ metrics.setdefault("dockq_>0.23", []).append(
+ np.mean(
+ [float(v > 0.23) for v in eval_data["dockq"] if v is not None]
+ )
+ )
+ metrics.setdefault("dockq_>0.49", []).append(
+ np.mean(
+ [float(v > 0.49) for v in eval_data["dockq"] if v is not None]
+ )
+ )
+ metrics.setdefault("len_dockq_", []).append(
+ len([v for v in eval_data["dockq"] if v is not None])
+ )
+
+ eval_file = Path(evals) / f"{name}_model_{model_id}_ligand.json"
+ with eval_file.open("r") as f:
+ eval_data = json.load(f)
+ if "lddt_pli" in eval_data:
+ lddt_plis = [
+ x["score"] for x in eval_data["lddt_pli"]["assigned_scores"]
+ ]
+ for _ in eval_data["lddt_pli"][
+ "model_ligand_unassigned_reason"
+ ].items():
+ lddt_plis.append(0)
+ if not lddt_plis:
+ continue
+ lddt_pli = np.mean([x for x in lddt_plis])
+ metrics.setdefault("lddt_pli", []).append(lddt_pli)
+ metrics.setdefault("len_lddt_pli", []).append(len(lddt_plis))
+
+ if "rmsd" in eval_data:
+ rmsds = [x["score"] for x in eval_data["rmsd"]["assigned_scores"]]
+ for _ in eval_data["rmsd"]["model_ligand_unassigned_reason"].items():
+ rmsds.append(100)
+ if not rmsds:
+ continue
+ rmsd2 = np.mean([x < 2.0 for x in rmsds])
+ rmsd5 = np.mean([x < 5.0 for x in rmsds])
+ metrics.setdefault("rmsd<2", []).append(rmsd2)
+ metrics.setdefault("rmsd<5", []).append(rmsd5)
+ metrics.setdefault("len_rmsd", []).append(len(rmsds))
+
+ # Get oracle
+ oracle = {k: min(v) if k == "rmsd" else max(v) for k, v in metrics.items()}
+ avg = {k: sum(v) / len(v) for k, v in metrics.items()}
+ top1 = {k: v[top_model] for k, v in metrics.items()}
+
+ results = {}
+ for metric_name in metrics:
+ if metric_name.startswith("len_"):
+ continue
+ if metric_name == "lddt_pli":
+ l = metrics["len_lddt_pli"][0]
+ elif metric_name == "rmsd<2" or metric_name == "rmsd<5":
+ l = metrics["len_rmsd"][0]
+ elif metric_name == "dockq_>0.23" or metric_name == "dockq_>0.49":
+ l = metrics["len_dockq_"][0]
+ else:
+ l = 1
+ results[metric_name] = {
+ "oracle": oracle[metric_name],
+ "average": avg[metric_name],
+ "top1": top1[metric_name],
+ "len": l,
+ }
+
+ return results
+
+
+def compute_boltz_metrics(preds, evals, name):
+ metrics = {}
+
+ top_model = None
+ top_confidence = 0
+ for model_id in range(5):
+ # Load confidence file
+ confidence_file = (
+ Path(preds) / f"confidence_{Path(preds).name}_model_{model_id}.json"
+ )
+ with confidence_file.open("r") as f:
+ confidence_data = json.load(f)
+ confidence = confidence_data["confidence_score"]
+ if confidence > top_confidence:
+ top_model = model_id
+ top_confidence = confidence
+
+ # Load eval file
+ eval_file = Path(evals) / f"{name}_model_{model_id}.json"
+ with eval_file.open("r") as f:
+ eval_data = json.load(f)
+ for metric_name in METRICS:
+ if metric_name in eval_data:
+ metrics.setdefault(metric_name, []).append(eval_data[metric_name])
+
+ if "dockq" in eval_data and eval_data["dockq"] is not None:
+ metrics.setdefault("dockq_>0.23", []).append(
+ np.mean(
+ [float(v > 0.23) for v in eval_data["dockq"] if v is not None]
+ )
+ )
+ metrics.setdefault("dockq_>0.49", []).append(
+ np.mean(
+ [float(v > 0.49) for v in eval_data["dockq"] if v is not None]
+ )
+ )
+ metrics.setdefault("len_dockq_", []).append(
+ len([v for v in eval_data["dockq"] if v is not None])
+ )
+
+ eval_file = Path(evals) / f"{name}_model_{model_id}_ligand.json"
+ with eval_file.open("r") as f:
+ eval_data = json.load(f)
+ if "lddt_pli" in eval_data:
+ lddt_plis = [
+ x["score"] for x in eval_data["lddt_pli"]["assigned_scores"]
+ ]
+ for _ in eval_data["lddt_pli"][
+ "model_ligand_unassigned_reason"
+ ].items():
+ lddt_plis.append(0)
+ if not lddt_plis:
+ continue
+ lddt_pli = np.mean([x for x in lddt_plis])
+ metrics.setdefault("lddt_pli", []).append(lddt_pli)
+ metrics.setdefault("len_lddt_pli", []).append(len(lddt_plis))
+
+ if "rmsd" in eval_data:
+ rmsds = [x["score"] for x in eval_data["rmsd"]["assigned_scores"]]
+ for _ in eval_data["rmsd"]["model_ligand_unassigned_reason"].items():
+ rmsds.append(100)
+ if not rmsds:
+ continue
+ rmsd2 = np.mean([x < 2.0 for x in rmsds])
+ rmsd5 = np.mean([x < 5.0 for x in rmsds])
+ metrics.setdefault("rmsd<2", []).append(rmsd2)
+ metrics.setdefault("rmsd<5", []).append(rmsd5)
+ metrics.setdefault("len_rmsd", []).append(len(rmsds))
+
+ # Get oracle
+ oracle = {k: min(v) if k == "rmsd" else max(v) for k, v in metrics.items()}
+ avg = {k: sum(v) / len(v) for k, v in metrics.items()}
+ top1 = {k: v[top_model] for k, v in metrics.items()}
+
+ results = {}
+ for metric_name in metrics:
+ if metric_name.startswith("len_"):
+ continue
+ if metric_name == "lddt_pli":
+ l = metrics["len_lddt_pli"][0]
+ elif metric_name == "rmsd<2" or metric_name == "rmsd<5":
+ l = metrics["len_rmsd"][0]
+ elif metric_name == "dockq_>0.23" or metric_name == "dockq_>0.49":
+ l = metrics["len_dockq_"][0]
+ else:
+ l = 1
+ results[metric_name] = {
+ "oracle": oracle[metric_name],
+ "average": avg[metric_name],
+ "top1": top1[metric_name],
+ "len": l,
+ }
+
+ return results
+
+
+def eval_models(
+ chai_preds,
+ chai_evals,
+ af3_preds,
+ af3_evals,
+ boltz_preds,
+ boltz_evals,
+ boltz_preds_x,
+ boltz_evals_x,
+):
+ # Load preds and make sure we have predictions for all models
+ chai_preds_names = {
+ x.name.lower(): x
+ for x in Path(chai_preds).iterdir()
+ if not x.name.lower().startswith(".")
+ }
+ af3_preds_names = {
+ x.name.lower(): x
+ for x in Path(af3_preds).iterdir()
+ if not x.name.lower().startswith(".")
+ }
+ boltz_preds_names = {
+ x.name.lower(): x
+ for x in Path(boltz_preds).iterdir()
+ if not x.name.lower().startswith(".")
+ }
+ boltz_preds_names_x = {
+ x.name.lower(): x
+ for x in Path(boltz_preds_x).iterdir()
+ if not x.name.lower().startswith(".")
+ }
+
+ print("Chai preds", len(chai_preds_names))
+ print("Af3 preds", len(af3_preds_names))
+ print("Boltz preds", len(boltz_preds_names))
+ print("Boltzx preds", len(boltz_preds_names_x))
+
+ common = (
+ set(chai_preds_names.keys())
+ & set(af3_preds_names.keys())
+ & set(boltz_preds_names.keys())
+ & set(boltz_preds_names_x.keys())
+ )
+
+ # Remove examples in the validation set
+ keys_to_remove = ["t1133", "h1134", "r1134s1", "t1134s2", "t1121", "t1123", "t1159"]
+ for key in keys_to_remove:
+ if key in common:
+ common.remove(key)
+ print("Common", len(common))
+
+ # Create a dataframe with the following schema:
+ # tool, name, metric, oracle, average, top1
+ results = []
+ for name in tqdm(common):
+ try:
+ af3_results = compute_af3_metrics(
+ af3_preds_names[name],
+ af3_evals,
+ name,
+ )
+
+ except Exception as e:
+ import traceback
+
+ traceback.print_exc()
+ print(f"Error evaluating AF3 {name}: {e}")
+ continue
+ try:
+ chai_results = compute_chai_metrics(
+ chai_preds_names[name],
+ chai_evals,
+ name,
+ )
+ except Exception as e:
+ import traceback
+
+ traceback.print_exc()
+ print(f"Error evaluating Chai {name}: {e}")
+ continue
+ try:
+ boltz_results = compute_boltz_metrics(
+ boltz_preds_names[name],
+ boltz_evals,
+ name,
+ )
+ except Exception as e:
+ import traceback
+
+ traceback.print_exc()
+ print(f"Error evaluating Boltz {name}: {e}")
+ continue
+
+ try:
+ boltz_results_x = compute_boltz_metrics(
+ boltz_preds_names_x[name],
+ boltz_evals_x,
+ name,
+ )
+ except Exception as e:
+ import traceback
+
+ traceback.print_exc()
+ print(f"Error evaluating Boltzx {name}: {e}")
+ continue
+
+ for metric_name in af3_results:
+ if metric_name in chai_results and metric_name in boltz_results:
+ if (
+ (
+ af3_results[metric_name]["len"]
+ == chai_results[metric_name]["len"]
+ )
+ and (
+ af3_results[metric_name]["len"]
+ == boltz_results[metric_name]["len"]
+ )
+ and (
+ af3_results[metric_name]["len"]
+ == boltz_results_x[metric_name]["len"]
+ )
+ ):
+ results.append(
+ {
+ "tool": "AF3 oracle",
+ "target": name,
+ "metric": metric_name,
+ "value": af3_results[metric_name]["oracle"],
+ }
+ )
+ results.append(
+ {
+ "tool": "AF3 top-1",
+ "target": name,
+ "metric": metric_name,
+ "value": af3_results[metric_name]["top1"],
+ }
+ )
+ results.append(
+ {
+ "tool": "Chai-1 oracle",
+ "target": name,
+ "metric": metric_name,
+ "value": chai_results[metric_name]["oracle"],
+ }
+ )
+ results.append(
+ {
+ "tool": "Chai-1 top-1",
+ "target": name,
+ "metric": metric_name,
+ "value": chai_results[metric_name]["top1"],
+ }
+ )
+ results.append(
+ {
+ "tool": "Boltz-1 oracle",
+ "target": name,
+ "metric": metric_name,
+ "value": boltz_results[metric_name]["oracle"],
+ }
+ )
+ results.append(
+ {
+ "tool": "Boltz-1 top-1",
+ "target": name,
+ "metric": metric_name,
+ "value": boltz_results[metric_name]["top1"],
+ }
+ )
+ results.append(
+ {
+ "tool": "Boltz-1x oracle",
+ "target": name,
+ "metric": metric_name,
+ "value": boltz_results_x[metric_name]["oracle"],
+ }
+ )
+ results.append(
+ {
+ "tool": "Boltz-1x top-1",
+ "target": name,
+ "metric": metric_name,
+ "value": boltz_results_x[metric_name]["top1"],
+ }
+ )
+ else:
+ print(
+ "Different lengths",
+ name,
+ metric_name,
+ af3_results[metric_name]["len"],
+ chai_results[metric_name]["len"],
+ boltz_results[metric_name]["len"],
+ boltz_results_x[metric_name]["len"],
+ )
+ else:
+ print(
+ "Missing metric",
+ name,
+ metric_name,
+ metric_name in chai_results,
+ metric_name in boltz_results,
+ metric_name in boltz_results_x,
+ )
+
+ # Write the results to a file, ensure we only keep the target & metrics where we have all tools
+ df = pd.DataFrame(results)
+ return df
+
+
+def eval_validity_checks(df):
+ # Filter the dataframe to only include the targets in the validity checks
+ name_mapping = {
+ "af3": "AF3 top-1",
+ "chai": "Chai-1 top-1",
+ "boltz1": "Boltz-1 top-1",
+ "boltz1x": "Boltz-1x top-1",
+ }
+ top1 = df[df["model_idx"] == 0]
+ top1 = top1[["tool", "pdb_id", "valid"]]
+ top1["tool"] = top1["tool"].apply(lambda x: name_mapping[x])
+ top1 = top1.rename(columns={"tool": "tool", "pdb_id": "target", "valid": "value"})
+ top1["metric"] = "physical validity"
+ top1["target"] = top1["target"].apply(lambda x: x.lower())
+ top1 = top1[["tool", "target", "metric", "value"]]
+
+ name_mapping = {
+ "af3": "AF3 oracle",
+ "chai": "Chai-1 oracle",
+ "boltz1": "Boltz-1 oracle",
+ "boltz1x": "Boltz-1x oracle",
+ }
+ oracle = df[["tool", "model_idx", "pdb_id", "valid"]]
+ oracle = oracle.groupby(["tool", "pdb_id"])["valid"].max().reset_index()
+ oracle = oracle.rename(
+ columns={"tool": "tool", "pdb_id": "target", "valid": "value"}
+ )
+ oracle["tool"] = oracle["tool"].apply(lambda x: name_mapping[x])
+ oracle["metric"] = "physical validity"
+ oracle = oracle[["tool", "target", "metric", "value"]]
+ oracle["target"] = oracle["target"].apply(lambda x: x.lower())
+ out = pd.concat([top1, oracle])
+ return out
+
+
+def bootstrap_ci(series, n_boot=1000, alpha=0.05):
+ """
+ Compute 95% bootstrap confidence intervals for the mean of 'series'.
+ """
+ n = len(series)
+ boot_means = []
+ # Perform bootstrap resampling
+ for _ in range(n_boot):
+ sample = series.sample(n, replace=True)
+ boot_means.append(sample.mean())
+
+ boot_means = np.array(boot_means)
+ mean_val = np.mean(series)
+ lower = np.percentile(boot_means, 100 * alpha / 2)
+ upper = np.percentile(boot_means, 100 * (1 - alpha / 2))
+ return mean_val, lower, upper
+
+
+def plot_data(desired_tools, desired_metrics, df, dataset, filename):
+ filtered_df = df[
+ df["tool"].isin(desired_tools) & df["metric"].isin(desired_metrics)
+ ]
+
+ # Apply bootstrap to each (tool, metric) group
+ boot_stats = filtered_df.groupby(["tool", "metric"])["value"].apply(bootstrap_ci)
+
+ # boot_stats is a Series of tuples (mean, lower, upper). Convert to DataFrame:
+ boot_stats = boot_stats.apply(pd.Series)
+ boot_stats.columns = ["mean", "lower", "upper"]
+
+ # Unstack to get a DataFrame suitable for plotting
+ plot_data = boot_stats["mean"].unstack("tool")
+ plot_data = plot_data.reindex(desired_metrics)
+
+ lower_data = boot_stats["lower"].unstack("tool")
+ lower_data = lower_data.reindex(desired_metrics)
+
+ upper_data = boot_stats["upper"].unstack("tool")
+ upper_data = upper_data.reindex(desired_metrics)
+
+ # If you need a specific order of tools:
+ tool_order = [
+ "AF3 oracle",
+ "AF3 top-1",
+ "Chai-1 oracle",
+ "Chai-1 top-1",
+ "Boltz-1 oracle",
+ "Boltz-1 top-1",
+ "Boltz-1x oracle",
+ "Boltz-1x top-1",
+ ]
+ plot_data = plot_data[tool_order]
+ lower_data = lower_data[tool_order]
+ upper_data = upper_data[tool_order]
+
+ # Rename metrics
+ renaming = {
+ "lddt_pli": "Mean LDDT-PLI",
+ "rmsd<2": "L-RMSD < 2A",
+ "lddt": "Mean LDDT",
+ "dockq_>0.23": "DockQ > 0.23",
+ "physical validity": "Physical Validity",
+ }
+ plot_data = plot_data.rename(index=renaming)
+ lower_data = lower_data.rename(index=renaming)
+ upper_data = upper_data.rename(index=renaming)
+ mean_vals = plot_data.values
+
+ # Colors
+ tool_colors = [
+ "#994C00", # AF3 oracle
+ "#FFB55A", # AF3 top-1
+ "#931652", # Chai-1 oracle
+ "#FC8AD9", # Chai-1 top-1
+ "#188F52", # Boltz-1 oracle
+ "#86E935", # Boltz-1 top-1
+ "#004D80", # Boltz-1x oracle
+ "#55C2FF", # Boltz-1x top-1
+ ]
+
+ fig, ax = plt.subplots(figsize=(10, 5))
+
+ x = np.arange(len(plot_data.index))
+ bar_spacing = 0.015
+ total_width = 0.7
+ # Adjust width to account for the spacing
+ width = (total_width - (len(tool_order) - 1) * bar_spacing) / len(tool_order)
+
+ for i, tool in enumerate(tool_order):
+ # Each subsequent bar moves over by width + bar_spacing
+ offsets = x - (total_width - width) / 2 + i * (width + bar_spacing)
+ # Extract the means and errors for this tool
+ tool_means = plot_data[tool].values
+ tool_yerr_lower = mean_vals[:, i] - lower_data.values[:, i]
+ tool_yerr_upper = upper_data.values[:, i] - mean_vals[:, i]
+ # Construct yerr array specifically for this tool
+ tool_yerr = np.vstack([tool_yerr_lower, tool_yerr_upper])
+
+ ax.bar(
+ offsets,
+ tool_means,
+ width=width,
+ color=tool_colors[i],
+ label=tool,
+ yerr=tool_yerr,
+ capsize=2,
+ error_kw={"elinewidth": 0.75},
+ )
+
+ ax.set_xticks(x)
+ ax.set_xticklabels(plot_data.index, rotation=0)
+ ax.set_ylabel("Value")
+ ax.set_title(f"Performances on {dataset} with 95% CI (Bootstrap)")
+
+ plt.tight_layout()
+ ax.legend(loc="lower center", bbox_to_anchor=(0.5, 0.85), ncols=4, frameon=False)
+
+ plt.savefig(filename)
+ plt.show()
+
+
+def main():
+ eval_folder = "../../boltz_results_final/"
+ output_folder = "../../boltz_results_final/"
+
+ # Eval the test set
+ chai_preds = eval_folder + "outputs/test/chai"
+ chai_evals = eval_folder + "evals/test/chai"
+
+ af3_preds = eval_folder + "outputs/test/af3"
+ af3_evals = eval_folder + "evals/test/af3"
+
+ boltz_preds = eval_folder + "outputs/test/boltz/predictions"
+ boltz_evals = eval_folder + "evals/test/boltz"
+
+ boltz_preds_x = eval_folder + "outputs/test/boltzx/predictions"
+ boltz_evals_x = eval_folder + "evals/test/boltzx"
+
+ validity_checks = eval_folder + "physical_checks_test.csv"
+
+ df_validity_checks = pd.read_csv(validity_checks)
+ df_validity_checks = eval_validity_checks(df_validity_checks)
+
+ df = eval_models(
+ chai_preds,
+ chai_evals,
+ af3_preds,
+ af3_evals,
+ boltz_preds,
+ boltz_evals,
+ boltz_preds_x,
+ boltz_evals_x,
+ )
+
+ df = pd.concat([df, df_validity_checks]).reset_index(drop=True)
+ df.to_csv(output_folder + "results_test.csv", index=False)
+
+ desired_tools = [
+ "AF3 oracle",
+ "AF3 top-1",
+ "Chai-1 oracle",
+ "Chai-1 top-1",
+ "Boltz-1 oracle",
+ "Boltz-1 top-1",
+ "Boltz-1x oracle",
+ "Boltz-1x top-1",
+ ]
+ desired_metrics = ["lddt", "dockq_>0.23", "lddt_pli", "rmsd<2", "physical validity"]
+ plot_data(
+ desired_tools, desired_metrics, df, "PDB Test", output_folder + "plot_test.pdf"
+ )
+
+ # Eval CASP
+ chai_preds = eval_folder + "outputs/casp15/chai"
+ chai_evals = eval_folder + "evals/casp15/chai"
+
+ af3_preds = eval_folder + "outputs/casp15/af3"
+ af3_evals = eval_folder + "evals/casp15/af3"
+
+ boltz_preds = eval_folder + "outputs/casp15/boltz/predictions"
+ boltz_evals = eval_folder + "evals/casp15/boltz"
+
+ boltz_preds_x = eval_folder + "outputs/casp15/boltzx/predictions"
+ boltz_evals_x = eval_folder + "evals/casp15/boltzx"
+
+ validity_checks = eval_folder + "physical_checks_casp.csv"
+
+ df_validity_checks = pd.read_csv(validity_checks)
+ df_validity_checks = eval_validity_checks(df_validity_checks)
+
+ df = eval_models(
+ chai_preds,
+ chai_evals,
+ af3_preds,
+ af3_evals,
+ boltz_preds,
+ boltz_evals,
+ boltz_preds_x,
+ boltz_evals_x,
+ )
+
+ df = pd.concat([df, df_validity_checks]).reset_index(drop=True)
+ df.to_csv(output_folder + "results_casp.csv", index=False)
+
+ plot_data(
+ desired_tools, desired_metrics, df, "CASP15", output_folder + "plot_casp.pdf"
+ )
+
+
+if __name__ == "__main__":
+ main()
diff --git a/forks/boltz/scripts/eval/physcialsim_metrics.py b/forks/boltz/scripts/eval/physcialsim_metrics.py
new file mode 100644
index 00000000..8a6f7c7d
--- /dev/null
+++ b/forks/boltz/scripts/eval/physcialsim_metrics.py
@@ -0,0 +1,304 @@
+import os
+import pickle
+
+import numpy as np
+import torch
+from pathlib import Path
+from tqdm import tqdm
+import pandas as pd
+from boltz.data.mol import load_molecules
+from boltz.data import const
+from boltz.data.parse.mmcif_with_constraints import parse_mmcif
+from multiprocessing import Pool
+
+
+def compute_torsion_angles(coords, torsion_index):
+ r_ij = coords[..., torsion_index[0], :] - coords[..., torsion_index[1], :]
+ r_kj = coords[..., torsion_index[2], :] - coords[..., torsion_index[1], :]
+ r_kl = coords[..., torsion_index[2], :] - coords[..., torsion_index[3], :]
+ n_ijk = np.cross(r_ij, r_kj, axis=-1)
+ n_jkl = np.cross(r_kj, r_kl, axis=-1)
+ r_kj_norm = np.linalg.norm(r_kj, axis=-1)
+ n_ijk_norm = np.linalg.norm(n_ijk, axis=-1)
+ n_jkl_norm = np.linalg.norm(n_jkl, axis=-1)
+ sign_phi = np.sign(
+ r_kj[..., None, :] @ np.cross(n_ijk, n_jkl, axis=-1)[..., None]
+ ).squeeze(axis=(-1, -2))
+ phi = sign_phi * np.arccos(
+ np.clip(
+ (n_ijk[..., None, :] @ n_jkl[..., None]).squeeze(axis=(-1, -2))
+ / (n_ijk_norm * n_jkl_norm),
+ -1 + 1e-8,
+ 1 - 1e-8,
+ )
+ )
+ return phi
+
+
+def check_ligand_distance_geometry(
+ structure, constraints, bond_buffer=0.25, angle_buffer=0.25, clash_buffer=0.2
+):
+ coords = structure.coords["coords"]
+ rdkit_bounds_constraints = constraints.rdkit_bounds_constraints
+ pair_index = rdkit_bounds_constraints["atom_idxs"].copy().astype(np.int64).T
+ bond_mask = rdkit_bounds_constraints["is_bond"].copy().astype(bool)
+ angle_mask = rdkit_bounds_constraints["is_angle"].copy().astype(bool)
+ upper_bounds = rdkit_bounds_constraints["upper_bound"].copy().astype(np.float32)
+ lower_bounds = rdkit_bounds_constraints["lower_bound"].copy().astype(np.float32)
+ dists = np.linalg.norm(coords[pair_index[0]] - coords[pair_index[1]], axis=-1)
+ bond_length_violations = (
+ dists[bond_mask] <= lower_bounds[bond_mask] * (1.0 - bond_buffer)
+ ) + (dists[bond_mask] >= upper_bounds[bond_mask] * (1.0 + bond_buffer))
+ bond_angle_violations = (
+ dists[angle_mask] <= lower_bounds[angle_mask] * (1.0 - angle_buffer)
+ ) + (dists[angle_mask] >= upper_bounds[angle_mask] * (1.0 + angle_buffer))
+ internal_clash_violations = dists[~bond_mask * ~angle_mask] <= lower_bounds[
+ ~bond_mask * ~angle_mask
+ ] * (1.0 - clash_buffer)
+ num_ligands = sum(
+ [
+ int(const.chain_types[chain["mol_type"]] == "NONPOLYMER")
+ for chain in structure.chains
+ ]
+ )
+ return {
+ "num_ligands": num_ligands,
+ "num_bond_length_violations": bond_length_violations.sum(),
+ "num_bonds": bond_mask.sum(),
+ "num_bond_angle_violations": bond_angle_violations.sum(),
+ "num_angles": angle_mask.sum(),
+ "num_internal_clash_violations": internal_clash_violations.sum(),
+ "num_non_neighbors": (~bond_mask * ~angle_mask).sum(),
+ }
+
+
+def check_ligand_stereochemistry(structure, constraints):
+ coords = structure.coords["coords"]
+ chiral_atom_constraints = constraints.chiral_atom_constraints
+ stereo_bond_constraints = constraints.stereo_bond_constraints
+
+ chiral_atom_index = chiral_atom_constraints["atom_idxs"].T
+ true_chiral_atom_orientations = chiral_atom_constraints["is_r"]
+ chiral_atom_ref_mask = chiral_atom_constraints["is_reference"]
+ chiral_atom_index = chiral_atom_index[:, chiral_atom_ref_mask]
+ true_chiral_atom_orientations = true_chiral_atom_orientations[chiral_atom_ref_mask]
+ pred_chiral_atom_orientations = (
+ compute_torsion_angles(coords, chiral_atom_index) > 0
+ )
+ chiral_atom_violations = (
+ pred_chiral_atom_orientations != true_chiral_atom_orientations
+ )
+
+ stereo_bond_index = stereo_bond_constraints["atom_idxs"].T
+ true_stereo_bond_orientations = stereo_bond_constraints["is_e"]
+ stereo_bond_ref_mask = stereo_bond_constraints["is_reference"]
+ stereo_bond_index = stereo_bond_index[:, stereo_bond_ref_mask]
+ true_stereo_bond_orientations = true_stereo_bond_orientations[stereo_bond_ref_mask]
+ pred_stereo_bond_orientations = (
+ np.abs(compute_torsion_angles(coords, stereo_bond_index)) > np.pi / 2
+ )
+ stereo_bond_violations = (
+ pred_stereo_bond_orientations != true_stereo_bond_orientations
+ )
+
+ return {
+ "num_chiral_atom_violations": chiral_atom_violations.sum(),
+ "num_chiral_atoms": chiral_atom_index.shape[1],
+ "num_stereo_bond_violations": stereo_bond_violations.sum(),
+ "num_stereo_bonds": stereo_bond_index.shape[1],
+ }
+
+
+def check_ligand_flatness(structure, constraints, buffer=0.25):
+ coords = structure.coords["coords"]
+
+ planar_ring_5_index = constraints.planar_ring_5_constraints["atom_idxs"]
+ ring_5_coords = coords[planar_ring_5_index, :]
+ centered_ring_5_coords = ring_5_coords - ring_5_coords.mean(axis=-2, keepdims=True)
+ ring_5_vecs = np.linalg.svd(centered_ring_5_coords)[2][..., -1, :, None]
+ ring_5_dists = np.abs((centered_ring_5_coords @ ring_5_vecs).squeeze(axis=-1))
+ ring_5_violations = np.all(ring_5_dists <= buffer, axis=-1)
+
+ planar_ring_6_index = constraints.planar_ring_6_constraints["atom_idxs"]
+ ring_6_coords = coords[planar_ring_6_index, :]
+ centered_ring_6_coords = ring_6_coords - ring_6_coords.mean(axis=-2, keepdims=True)
+ ring_6_vecs = np.linalg.svd(centered_ring_6_coords)[2][..., -1, :, None]
+ ring_6_dists = np.abs((centered_ring_6_coords @ ring_6_vecs)).squeeze(axis=-1)
+ ring_6_violations = np.any(ring_6_dists >= buffer, axis=-1)
+
+ planar_bond_index = constraints.planar_bond_constraints["atom_idxs"]
+ bond_coords = coords[planar_bond_index, :]
+ centered_bond_coords = bond_coords - bond_coords.mean(axis=-2, keepdims=True)
+ bond_vecs = np.linalg.svd(centered_bond_coords)[2][..., -1, :, None]
+ bond_dists = np.abs((centered_bond_coords @ bond_vecs)).squeeze(axis=-1)
+ bond_violations = np.any(bond_dists >= buffer, axis=-1)
+
+ return {
+ "num_planar_5_ring_violations": ring_5_violations.sum(),
+ "num_planar_5_rings": ring_5_violations.shape[0],
+ "num_planar_6_ring_violations": ring_6_violations.sum(),
+ "num_planar_6_rings": ring_6_violations.shape[0],
+ "num_planar_double_bond_violations": bond_violations.sum(),
+ "num_planar_double_bonds": bond_violations.shape[0],
+ }
+
+
+def check_steric_clash(structure, molecules, buffer=0.25):
+ result = {}
+ for type_i in const.chain_types:
+ out_type_i = type_i.lower()
+ out_type_i = out_type_i if out_type_i != "nonpolymer" else "ligand"
+ result[f"num_chain_pairs_sym_{out_type_i}"] = 0
+ result[f"num_chain_clashes_sym_{out_type_i}"] = 0
+ for type_j in const.chain_types:
+ out_type_j = type_j.lower()
+ out_type_j = out_type_j if out_type_j != "nonpolymer" else "ligand"
+ result[f"num_chain_pairs_asym_{out_type_i}_{out_type_j}"] = 0
+ result[f"num_chain_clashes_asym_{out_type_i}_{out_type_j}"] = 0
+
+ connected_chains = set()
+ for bond in structure.bonds:
+ if bond["chain_1"] != bond["chain_2"]:
+ connected_chains.add(tuple(sorted((bond["chain_1"], bond["chain_2"]))))
+
+ vdw_radii = []
+ for res in structure.residues:
+ mol = molecules[res["name"]]
+ token_atoms = structure.atoms[
+ res["atom_idx"] : res["atom_idx"] + res["atom_num"]
+ ]
+ atom_name_to_ref = {a.GetProp("name"): a for a in mol.GetAtoms()}
+ token_atoms_ref = [atom_name_to_ref[a["name"]] for a in token_atoms]
+ vdw_radii.extend(
+ [const.vdw_radii[a.GetAtomicNum() - 1] for a in token_atoms_ref]
+ )
+ vdw_radii = np.array(vdw_radii, dtype=np.float32)
+
+ np.array([a.GetAtomicNum() for a in token_atoms_ref])
+ for i, chain_i in enumerate(structure.chains):
+ for j, chain_j in enumerate(structure.chains):
+ if (
+ chain_i["atom_num"] == 1
+ or chain_j["atom_num"] == 1
+ or j <= i
+ or (i, j) in connected_chains
+ ):
+ continue
+ coords_i = structure.coords["coords"][
+ chain_i["atom_idx"] : chain_i["atom_idx"] + chain_i["atom_num"]
+ ]
+ coords_j = structure.coords["coords"][
+ chain_j["atom_idx"] : chain_j["atom_idx"] + chain_j["atom_num"]
+ ]
+ dists = np.linalg.norm(coords_i[:, None, :] - coords_j[None, :, :], axis=-1)
+ radii_i = vdw_radii[
+ chain_i["atom_idx"] : chain_i["atom_idx"] + chain_i["atom_num"]
+ ]
+ radii_j = vdw_radii[
+ chain_j["atom_idx"] : chain_j["atom_idx"] + chain_j["atom_num"]
+ ]
+ radii_sum = radii_i[:, None] + radii_j[None, :]
+ is_clashing = np.any(dists < radii_sum * (1.00 - buffer))
+ type_i = const.chain_types[chain_i["mol_type"]].lower()
+ type_j = const.chain_types[chain_j["mol_type"]].lower()
+ type_i = type_i if type_i != "nonpolymer" else "ligand"
+ type_j = type_j if type_j != "nonpolymer" else "ligand"
+ is_symmetric = (
+ chain_i["entity_id"] == chain_j["entity_id"]
+ and chain_i["atom_num"] == chain_j["atom_num"]
+ )
+ if is_symmetric:
+ key = "sym_" + type_i
+ else:
+ key = "asym_" + type_i + "_" + type_j
+ result["num_chain_pairs_" + key] += 1
+ result["num_chain_clashes_" + key] += int(is_clashing)
+ return result
+
+
+cache_dir = Path("/data/rbg/users/jwohlwend/boltz-cache")
+ccd_path = cache_dir / "ccd.pkl"
+moldir = cache_dir / "mols"
+with ccd_path.open("rb") as file:
+ ccd = pickle.load(file)
+
+boltz1_dir = Path(
+ "/data/rbg/shared/projects/foldeverything/boltz_results_final/outputs/test/boltz/predictions"
+)
+boltz1x_dir = Path(
+ "/data/scratch/getzn/boltz_private/boltz_1x_test_results_final_new/full_predictions"
+)
+chai_dir = Path(
+ "/data/rbg/shared/projects/foldeverything/boltz_results_final/outputs/test/chai"
+)
+af3_dir = Path(
+ "/data/rbg/shared/projects/foldeverything/boltz_results_final/outputs/test/af3"
+)
+
+boltz1_pdb_ids = set(os.listdir(boltz1_dir))
+boltz1x_pdb_ids = set(os.listdir(boltz1x_dir))
+chai_pdb_ids = set(os.listdir(chai_dir))
+af3_pdb_ids = set([pdb_id for pdb_id in os.listdir(af3_dir)])
+common_pdb_ids = boltz1_pdb_ids & boltz1x_pdb_ids & chai_pdb_ids & af3_pdb_ids
+
+tools = ["boltz1", "boltz1x", "chai", "af3"]
+num_samples = 5
+
+
+def process_fn(key):
+ tool, pdb_id, model_idx = key
+ if tool == "boltz1":
+ cif_path = boltz1_dir / pdb_id / f"{pdb_id}_model_{model_idx}.cif"
+ elif tool == "boltz1x":
+ cif_path = boltz1x_dir / pdb_id / f"{pdb_id}_model_{model_idx}.cif"
+ elif tool == "chai":
+ cif_path = chai_dir / pdb_id / f"pred.model_idx_{model_idx}.cif"
+ elif tool == "af3":
+ cif_path = af3_dir / pdb_id.lower() / f"seed-1_sample-{model_idx}" / "model.cif"
+
+ parsed_structure = parse_mmcif(
+ cif_path,
+ ccd,
+ moldir,
+ )
+ structure = parsed_structure.data
+ constraints = parsed_structure.residue_constraints
+
+ record = {
+ "tool": tool,
+ "pdb_id": pdb_id,
+ "model_idx": model_idx,
+ }
+ record.update(check_ligand_distance_geometry(structure, constraints))
+ record.update(check_ligand_stereochemistry(structure, constraints))
+ record.update(check_ligand_flatness(structure, constraints))
+ record.update(check_steric_clash(structure, molecules=ccd))
+ return record
+
+
+keys = []
+for tool in tools:
+ for pdb_id in common_pdb_ids:
+ for model_idx in range(num_samples):
+ keys.append((tool, pdb_id, model_idx))
+
+process_fn(keys[0])
+records = []
+with Pool(48) as p:
+ with tqdm(total=len(keys)) as pbar:
+ for record in p.imap_unordered(process_fn, keys):
+ records.append(record)
+ pbar.update(1)
+df = pd.DataFrame.from_records(records)
+
+df["num_chain_clashes_all"] = df[
+ [key for key in df.columns if "chain_clash" in key]
+].sum(axis=1)
+df["num_pairs_all"] = df[[key for key in df.columns if "chain_pair" in key]].sum(axis=1)
+df["clash_free"] = df["num_chain_clashes_all"] == 0
+df["valid_ligand"] = (
+ df[[key for key in df.columns if "violation" in key]].sum(axis=1) == 0
+)
+df["valid"] = (df["clash_free"]) & (df["valid_ligand"])
+
+df.to_csv("physical_checks_test.csv")
diff --git a/forks/boltz/scripts/eval/run_evals.py b/forks/boltz/scripts/eval/run_evals.py
new file mode 100644
index 00000000..48f3a068
--- /dev/null
+++ b/forks/boltz/scripts/eval/run_evals.py
@@ -0,0 +1,167 @@
+import argparse
+import concurrent.futures
+import subprocess
+from pathlib import Path
+
+from tqdm import tqdm
+
+OST_COMPARE_STRUCTURE = r"""
+#!/bin/bash
+# https://openstructure.org/docs/2.7/actions/#ost-compare-structures
+
+IMAGE_NAME=openstructure-0.2.8
+
+command="compare-structures \
+-m {model_file} \
+-r {reference_file} \
+--fault-tolerant \
+--min-pep-length 4 \
+--min-nuc-length 4 \
+-o {output_path} \
+--lddt --bb-lddt --qs-score --dockq \
+--ics --ips --rigid-scores --patch-scores --tm-score"
+
+sudo docker run -u $(id -u):$(id -g) --rm --volume {mount}:{mount} $IMAGE_NAME $command
+"""
+
+
+OST_COMPARE_LIGAND = r"""
+#!/bin/bash
+# https://openstructure.org/docs/2.7/actions/#ost-compare-structures
+
+IMAGE_NAME=openstructure-0.2.8
+
+command="compare-ligand-structures \
+-m {model_file} \
+-r {reference_file} \
+--fault-tolerant \
+--lddt-pli --rmsd \
+--substructure-match \
+-o {output_path}"
+
+sudo docker run -u $(id -u):$(id -g) --rm --volume {mount}:{mount} $IMAGE_NAME $command
+"""
+
+
+def evaluate_structure(
+ name: str,
+ pred: Path,
+ reference: Path,
+ outdir: str,
+ mount: str,
+ executable: str = "/bin/bash",
+) -> None:
+ """Evaluate the structure."""
+ # Evaluate polymer metrics
+ out_path = Path(outdir) / f"{name}.json"
+
+ if out_path.exists():
+ print( # noqa: T201
+ f"Skipping recomputation of {name} as protein json file already exists"
+ )
+ else:
+ subprocess.run(
+ OST_COMPARE_STRUCTURE.format(
+ model_file=str(pred),
+ reference_file=str(reference),
+ output_path=str(out_path),
+ mount=mount,
+ ),
+ shell=True, # noqa: S602
+ check=False,
+ executable=executable,
+ capture_output=True,
+ )
+
+ # Evaluate ligand metrics
+ out_path = Path(outdir) / f"{name}_ligand.json"
+ if out_path.exists():
+ print(f"Skipping recomputation of {name} as ligand json file already exists") # noqa: T201
+ else:
+ subprocess.run(
+ OST_COMPARE_LIGAND.format(
+ model_file=str(pred),
+ reference_file=str(reference),
+ output_path=str(out_path),
+ mount=mount,
+ ),
+ shell=True, # noqa: S602
+ check=False,
+ executable=executable,
+ capture_output=True,
+ )
+
+
+def main(args):
+ # Aggregate the predictions and references
+ files = list(args.data.iterdir())
+ names = {f.stem.lower(): f for f in files}
+
+ # Create the output directory
+ args.outdir.mkdir(parents=True, exist_ok=True)
+
+ first_item = True
+ with concurrent.futures.ThreadPoolExecutor(args.max_workers) as executor:
+ futures = []
+ for name, folder in names.items():
+ for model_id in range(5):
+ # Split the input data
+ if args.format == "af3":
+ pred_path = folder / f"seed-1_sample-{model_id}" / "model.cif"
+ elif args.format == "chai":
+ pred_path = folder / f"pred.model_idx_{model_id}.cif"
+ elif args.format == "boltz":
+ name_file = (
+ f"{name[0].upper()}{name[1:]}"
+ if args.testset == "casp"
+ else name.lower()
+ )
+ pred_path = folder / f"{name_file}_model_{model_id}.cif"
+
+ if args.testset == "casp":
+ ref_path = args.pdb / f"{name[0].upper()}{name[1:]}.cif"
+ elif args.testset == "test":
+ ref_path = args.pdb / f"{name.lower()}.cif.gz"
+
+ if first_item:
+ # Evaluate the first item in the first prediction
+ # Ensures that the docker image is downloaded
+ evaluate_structure(
+ name=f"{name}_model_{model_id}",
+ pred=str(pred_path),
+ reference=str(ref_path),
+ outdir=str(args.outdir),
+ mount=args.mount,
+ executable=args.executable,
+ )
+ first_item = False
+ else:
+ future = executor.submit(
+ evaluate_structure,
+ name=f"{name}_model_{model_id}",
+ pred=str(pred_path),
+ reference=str(ref_path),
+ outdir=str(args.outdir),
+ mount=args.mount,
+ executable=args.executable,
+ )
+ futures.append(future)
+
+ # Wait for all tasks to complete
+ with tqdm(total=len(futures)) as pbar:
+ for _ in concurrent.futures.as_completed(futures):
+ pbar.update(1)
+
+
+if __name__ == "__main__":
+ parser = argparse.ArgumentParser()
+ parser.add_argument("data", type=Path)
+ parser.add_argument("pdb", type=Path)
+ parser.add_argument("outdir", type=Path)
+ parser.add_argument("--format", type=str, default="af3")
+ parser.add_argument("--testset", type=str, default="casp")
+ parser.add_argument("--mount", type=str)
+ parser.add_argument("--executable", type=str, default="/bin/bash")
+ parser.add_argument("--max-workers", type=int, default=32)
+ args = parser.parse_args()
+ main(args)
diff --git a/forks/boltz/scripts/process/README.md b/forks/boltz/scripts/process/README.md
new file mode 100644
index 00000000..db33fd65
--- /dev/null
+++ b/forks/boltz/scripts/process/README.md
@@ -0,0 +1 @@
+Please see our [data processing instructions](../../docs/training.md).
\ No newline at end of file
diff --git a/forks/boltz/scripts/process/ccd.py b/forks/boltz/scripts/process/ccd.py
new file mode 100644
index 00000000..080b2285
--- /dev/null
+++ b/forks/boltz/scripts/process/ccd.py
@@ -0,0 +1,295 @@
+"""Compute conformers and symmetries for all the CCD molecules."""
+
+import argparse
+import multiprocessing
+import pickle
+import sys
+from functools import partial
+from pathlib import Path
+
+import pandas as pd
+import rdkit
+from p_tqdm import p_uimap
+from pdbeccdutils.core import ccd_reader
+from pdbeccdutils.core.component import ConformerType
+from rdkit import rdBase
+from rdkit.Chem import AllChem
+from rdkit.Chem.rdchem import Conformer, Mol
+from tqdm import tqdm
+
+
+def load_molecules(components: str) -> list[Mol]:
+ """Load the CCD components file.
+
+ Parameters
+ ----------
+ components : str
+ Path to the CCD components file.
+
+ Returns
+ -------
+ list[Mol]
+
+ """
+ components: dict[str, ccd_reader.CCDReaderResult]
+ components = ccd_reader.read_pdb_components_file(components)
+
+ mols = []
+ for name, component in components.items():
+ mol = component.component.mol
+ mol.SetProp("PDB_NAME", name)
+ mols.append(mol)
+
+ return mols
+
+
+def compute_3d(mol: Mol, version: str = "v3") -> bool:
+ """Generate 3D coordinates using EKTDG method.
+
+ Taken from `pdbeccdutils.core.component.Component`.
+
+ Parameters
+ ----------
+ mol: Mol
+ The RDKit molecule to process
+ version: str, optional
+ The ETKDG version, defaults ot v3
+
+ Returns
+ -------
+ bool
+ Whether computation was successful.
+
+ """
+ if version == "v3":
+ options = rdkit.Chem.AllChem.ETKDGv3()
+ elif version == "v2":
+ options = rdkit.Chem.AllChem.ETKDGv2()
+ else:
+ options = rdkit.Chem.AllChem.ETKDGv2()
+
+ options.clearConfs = False
+ conf_id = -1
+
+ try:
+ conf_id = rdkit.Chem.AllChem.EmbedMolecule(mol, options)
+ rdkit.Chem.AllChem.UFFOptimizeMolecule(mol, confId=conf_id, maxIters=1000)
+
+ except RuntimeError:
+ pass # Force field issue here
+ except ValueError:
+ pass # sanitization issue here
+
+ if conf_id != -1:
+ conformer = mol.GetConformer(conf_id)
+ conformer.SetProp("name", ConformerType.Computed.name)
+ conformer.SetProp("coord_generation", f"ETKDG{version}")
+
+ return True
+
+ return False
+
+
+def get_conformer(mol: Mol, c_type: ConformerType) -> Conformer:
+ """Retrieve an rdkit object for a deemed conformer.
+
+ Taken from `pdbeccdutils.core.component.Component`.
+
+ Parameters
+ ----------
+ mol: Mol
+ The molecule to process.
+ c_type: ConformerType
+ The conformer type to extract.
+
+ Returns
+ -------
+ Conformer
+ The desired conformer, if any.
+
+ Raises
+ ------
+ ValueError
+ If there are no conformers of the given tyoe.
+
+ """
+ for c in mol.GetConformers():
+ try:
+ if c.GetProp("name") == c_type.name:
+ return c
+ except KeyError: # noqa: PERF203
+ pass
+
+ msg = f"Conformer {c_type.name} does not exist."
+ raise ValueError(msg)
+
+
+def compute_symmetries(mol: Mol) -> list[list[int]]:
+ """Compute the symmetries of a molecule.
+
+ Parameters
+ ----------
+ mol : Mol
+ The molecule to process
+
+ Returns
+ -------
+ list[list[int]]
+ The symmetries as a list of index permutations
+
+ """
+ mol = AllChem.RemoveHs(mol)
+ idx_map = {}
+ atom_idx = 0
+ for i, atom in enumerate(mol.GetAtoms()):
+ # Skip if leaving atoms
+ if int(atom.GetProp("leaving_atom")):
+ continue
+ idx_map[i] = atom_idx
+ atom_idx += 1
+
+ # Calculate self permutations
+ permutations = []
+ raw_permutations = mol.GetSubstructMatches(mol, uniquify=False)
+ for raw_permutation in raw_permutations:
+ # Filter out permutations with leaving atoms
+ try:
+ if {raw_permutation[idx] for idx in idx_map} == set(idx_map.keys()):
+ permutation = [
+ idx_map[idx] for idx in raw_permutation if idx in idx_map
+ ]
+ permutations.append(permutation)
+ except Exception: # noqa: S110, PERF203, BLE001
+ pass
+ serialized_permutations = pickle.dumps(permutations)
+ mol.SetProp("symmetries", serialized_permutations.hex())
+ return permutations
+
+
+def process(mol: Mol, output: str) -> tuple[str, str]:
+ """Process a CCD component.
+
+ Parameters
+ ----------
+ mol : Mol
+ The molecule to process
+ output : str
+ The directory to save the molecules
+
+ Returns
+ -------
+ str
+ The name of the component
+ str
+ The result of the conformer generation
+
+ """
+ # Get name
+ name = mol.GetProp("PDB_NAME")
+
+ # Check if single atom
+ if mol.GetNumAtoms() == 1:
+ result = "single"
+ else:
+ # Get the 3D conformer
+ try:
+ # Try to generate a 3D conformer with RDKit
+ success = compute_3d(mol, version="v3")
+ if success:
+ _ = get_conformer(mol, ConformerType.Computed)
+ result = "computed"
+
+ # Otherwise, default to the ideal coordinates
+ else:
+ _ = get_conformer(mol, ConformerType.Ideal)
+ result = "ideal"
+ except ValueError:
+ result = "failed"
+
+ # Dump the molecule
+ path = Path(output) / f"{name}.pkl"
+ with path.open("wb") as f:
+ pickle.dump(mol, f)
+
+ # Output the results
+ return name, result
+
+
+def main(args: argparse.Namespace) -> None:
+ """Process conformers."""
+ # Set property saving
+ rdkit.Chem.SetDefaultPickleProperties(rdkit.Chem.PropertyPickleOptions.AllProps)
+
+ # Load components
+ print("Loading components") # noqa: T201
+ molecules = load_molecules(args.components)
+
+ # Reset stdout and stderr, as pdbccdutils messes with them
+ sys.stdout = sys.__stdout__
+ sys.stderr = sys.__stderr__
+
+ # Disable rdkit warnings
+ blocker = rdBase.BlockLogs() # noqa: F841
+
+ # Setup processing function
+ outdir = Path(args.outdir)
+ outdir.mkdir(parents=True, exist_ok=True)
+ mol_output = outdir / "mols"
+ mol_output.mkdir(parents=True, exist_ok=True)
+ process_fn = partial(process, output=str(mol_output))
+
+ # Process the files in parallel
+ print("Processing components") # noqa: T201
+ metadata = []
+
+ # Check if we can run in parallel
+ max_processes = multiprocessing.cpu_count()
+ num_processes = max(1, min(args.num_processes, max_processes, len(molecules)))
+ parallel = num_processes > 1
+
+ if parallel:
+ for name, result in p_uimap(
+ process_fn,
+ molecules,
+ num_cpus=num_processes,
+ ):
+ metadata.append({"name": name, "result": result})
+ else:
+ for mol in tqdm(molecules):
+ name, result = process_fn(mol)
+ metadata.append({"name": name, "result": result})
+
+ # Load and group outputs
+ molecules = {}
+ for item in metadata:
+ if item["result"] == "failed":
+ continue
+
+ # Load the mol file
+ path = mol_output / f"{item['name']}.pkl"
+ with path.open("rb") as f:
+ mol = pickle.load(f) # noqa: S301
+ molecules[item["name"]] = mol
+
+ # Dump metadata
+ path = outdir / "results.csv"
+ metadata = pd.DataFrame(metadata)
+ metadata.to_csv(path)
+
+ # Dump the components
+ path = outdir / "ccd.pkl"
+ with path.open("wb") as f:
+ pickle.dump(molecules, f)
+
+
+if __name__ == "__main__":
+ parser = argparse.ArgumentParser()
+ parser.add_argument("--components", type=str)
+ parser.add_argument("--outdir", type=str)
+ parser.add_argument(
+ "--num_processes",
+ type=int,
+ default=multiprocessing.cpu_count(),
+ )
+ args = parser.parse_args()
+ main(args)
diff --git a/forks/boltz/scripts/process/cluster.py b/forks/boltz/scripts/process/cluster.py
new file mode 100644
index 00000000..c45dcd99
--- /dev/null
+++ b/forks/boltz/scripts/process/cluster.py
@@ -0,0 +1,111 @@
+"""Create a mapping from structure and chain ID to MSA indices."""
+
+import argparse
+import hashlib
+import json
+import pickle
+import subprocess
+from pathlib import Path
+
+import pandas as pd
+from Bio import SeqIO
+
+
+def hash_sequence(seq: str) -> str:
+ """Hash a sequence."""
+ return hashlib.sha256(seq.encode()).hexdigest()
+
+
+def main(args: argparse.Namespace) -> None:
+ """Create clustering."""
+ # Set output directory
+ outdir = Path(args.outdir)
+ outdir.mkdir(parents=True, exist_ok=True)
+
+ # Split the sequences into proteins and nucleotides
+ with Path(args.sequences).open("r") as f:
+ data = list(SeqIO.parse(f, "fasta"))
+
+ proteins = set()
+ shorts = set()
+ nucleotides = set()
+
+ # Separate the sequences into proteins, nucleotides and short sequences
+ # Short sequences cause a bug in the clustering, so they are separated
+ for seq in data:
+ if set(str(seq.seq)).issubset({"A", "C", "G", "T", "U", "N"}):
+ nucleotides.add(str(seq.seq).strip())
+ elif len(str(seq.seq).strip()) < 10: # noqa: PLR2004
+ shorts.add(str(seq.seq).strip())
+ else:
+ proteins.add(str(seq.seq).strip())
+
+ # Run mmseqs on the protein data
+ proteins = [f">{hash_sequence(seq)}\n{seq}" for seq in proteins]
+ with (outdir / "proteins.fasta").open("w") as f:
+ f.write("\n".join(proteins))
+
+ subprocess.run(
+ f"{args.mmseqs} easy-cluster {outdir / 'proteins.fasta'} {outdir / 'clust_prot'} {outdir / 'tmp'} --min-seq-id 0.4", # noqa: E501
+ shell=True, # noqa: S602
+ check=True,
+ )
+
+ # Load protein clusters
+ clustering_path = outdir / "clust_prot_cluster.tsv"
+ protein_data = pd.read_csv(clustering_path, sep="\t", header=None)
+ clusters = protein_data[0]
+ items = protein_data[1]
+ clustering = dict(zip(list(items), list(clusters)))
+
+ # Each shqrt sequence is given an id
+ for short in shorts:
+ short_id = hash_sequence(short)
+ clustering[short_id] = short_id
+
+ # Each unique rna sequence is given an id
+ for nucl in nucleotides:
+ nucl_id = hash_sequence(nucl)
+ clustering[nucl_id] = nucl_id
+
+ # Load ligand data
+ with Path(args.ccd).open("rb") as handle:
+ ligand_data = pickle.load(handle) # noqa: S301
+
+ # Each unique ligand CCD is given an id
+ for ccd_code in ligand_data:
+ clustering[ccd_code] = ccd_code
+
+ # Save clustering
+ with (outdir / "clustering.json").open("w") as handle:
+ json.dump(clustering, handle)
+
+
+if __name__ == "__main__":
+ parser = argparse.ArgumentParser()
+ parser.add_argument(
+ "--sequences",
+ type=str,
+ help="Input to protein fasta.",
+ required=True,
+ )
+ parser.add_argument(
+ "--ccd",
+ type=str,
+ help="Input to rna fasta.",
+ required=True,
+ )
+ parser.add_argument(
+ "--outdir",
+ type=str,
+ help="Output directory.",
+ required=True,
+ )
+ parser.add_argument(
+ "--mmseqs",
+ type=str,
+ help="Path to mmseqs program.",
+ default="mmseqs",
+ )
+ args = parser.parse_args()
+ main(args)
diff --git a/forks/boltz/scripts/process/mmcif.py b/forks/boltz/scripts/process/mmcif.py
new file mode 100644
index 00000000..95cdb29e
--- /dev/null
+++ b/forks/boltz/scripts/process/mmcif.py
@@ -0,0 +1,1123 @@
+import contextlib
+from dataclasses import dataclass, replace
+from typing import Optional
+
+import gemmi
+import numpy as np
+from rdkit import rdBase
+from rdkit.Chem import AllChem
+from rdkit.Chem.rdchem import Conformer, Mol
+from sklearn.neighbors import KDTree
+
+from boltz.data import const
+from boltz.data.types import (
+ Atom,
+ Bond,
+ Chain,
+ Connection,
+ Interface,
+ Residue,
+ Structure,
+ StructureInfo,
+)
+
+####################################################################################################
+# DATACLASSES
+####################################################################################################
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedAtom:
+ """A parsed atom object."""
+
+ name: str
+ element: int
+ charge: int
+ coords: tuple[float, float, float]
+ conformer: tuple[float, float, float]
+ is_present: bool
+ chirality: int
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedBond:
+ """A parsed bond object."""
+
+ atom_1: int
+ atom_2: int
+ type: int
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedResidue:
+ """A parsed residue object."""
+
+ name: str
+ type: int
+ idx: int
+ atoms: list[ParsedAtom]
+ bonds: list[ParsedBond]
+ orig_idx: Optional[int]
+ atom_center: int
+ atom_disto: int
+ is_standard: bool
+ is_present: bool
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedChain:
+ """A parsed chain object."""
+
+ name: str
+ entity: str
+ type: str
+ residues: list[ParsedResidue]
+ sequence: list[str]
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedConnection:
+ """A parsed connection object."""
+
+ chain_1: str
+ chain_2: str
+ residue_index_1: int
+ residue_index_2: int
+ atom_index_1: str
+ atom_index_2: str
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedStructure:
+ """A parsed structure object."""
+
+ data: Structure
+ info: StructureInfo
+ covalents: list[int]
+
+
+####################################################################################################
+# HELPERS
+####################################################################################################
+
+
+def get_dates(block: gemmi.cif.Block) -> tuple[str, str, str]:
+ """Get the deposited, released, and last revision dates.
+
+ Parameters
+ ----------
+ block : gemmi.cif.Block
+ The block to process.
+
+ Returns
+ -------
+ str
+ The deposited date.
+ str
+ The released date.
+ str
+ The last revision date.
+
+ """
+ deposited = "_pdbx_database_status.recvd_initial_deposition_date"
+ revision = "_pdbx_audit_revision_history.revision_date"
+ deposit_date = revision_date = release_date = ""
+ with contextlib.suppress(Exception):
+ deposit_date = block.find([deposited])[0][0]
+ release_date = block.find([revision])[0][0]
+ revision_date = block.find([revision])[-1][0]
+
+ return deposit_date, release_date, revision_date
+
+
+def get_resolution(block: gemmi.cif.Block) -> float:
+ """Get the resolution from a gemmi structure.
+
+ Parameters
+ ----------
+ block : gemmi.cif.Block
+ The block to process.
+
+ Returns
+ -------
+ float
+ The resolution.
+
+ """
+ resolution = 0.0
+ for res_key in (
+ "_refine.ls_d_res_high",
+ "_em_3d_reconstruction.resolution",
+ "_reflns.d_resolution_high",
+ ):
+ with contextlib.suppress(Exception):
+ resolution = float(block.find([res_key])[0].str(0))
+ break
+ return resolution
+
+
+def get_method(block: gemmi.cif.Block) -> str:
+ """Get the method from a gemmi structure.
+
+ Parameters
+ ----------
+ block : gemmi.cif.Block
+ The block to process.
+
+ Returns
+ -------
+ str
+ The method.
+
+ """
+ method = ""
+ method_key = "_exptl.method"
+ with contextlib.suppress(Exception):
+ methods = block.find([method_key])
+ method = ",".join([m.str(0).lower() for m in methods])
+
+ return method
+
+
+def convert_atom_name(name: str) -> tuple[int, int, int, int]:
+ """Convert an atom name to a standard format.
+
+ Parameters
+ ----------
+ name : str
+ The atom name.
+
+ Returns
+ -------
+ tuple[int, int, int, int]
+ The converted atom name.
+
+ """
+ name = name.strip()
+ name = [ord(c) - 32 for c in name]
+ name = name + [0] * (4 - len(name))
+ return tuple(name)
+
+
+def get_unk_token(dtype: gemmi.PolymerType) -> str:
+ """Get the unknown token for a given entity type.
+
+ Parameters
+ ----------
+ dtype : gemmi.EntityType
+ The entity type.
+
+ Returns
+ -------
+ str
+ The unknown token.
+
+ """
+ if dtype == gemmi.PolymerType.PeptideL:
+ unk = const.unk_token["PROTEIN"]
+ elif dtype == gemmi.PolymerType.Dna:
+ unk = const.unk_token["DNA"]
+ elif dtype == gemmi.PolymerType.Rna:
+ unk = const.unk_token["RNA"]
+ else:
+ msg = f"Unknown polymer type: {dtype}"
+ raise ValueError(msg)
+
+ return unk
+
+
+def get_conformer(mol: Mol) -> Conformer:
+ """Retrieve an rdkit object for a deemed conformer.
+
+ Inspired by `pdbeccdutils.core.component.Component`.
+
+ Parameters
+ ----------
+ mol: Mol
+ The molecule to process.
+
+ Returns
+ -------
+ Conformer
+ The desired conformer, if any.
+
+ Raises
+ ------
+ ValueError
+ If there are no conformers of the given tyoe.
+
+ """
+ for c in mol.GetConformers():
+ try:
+ if c.GetProp("name") == "Computed":
+ return c
+ except KeyError: # noqa: PERF203
+ pass
+
+ for c in mol.GetConformers():
+ try:
+ if c.GetProp("name") == "Ideal":
+ return c
+ except KeyError: # noqa: PERF203
+ pass
+
+ msg = "Conformer does not exist."
+ raise ValueError(msg)
+
+
+def compute_covalent_ligands(
+ connections: list[gemmi.Connection],
+ subchain_map: dict[tuple[str, int], str],
+ entities: dict[str, gemmi.Entity],
+) -> set[str]:
+ """Compute the covalent ligands from a list of connections.
+
+ Parameters
+ ----------
+ connections: List[gemmi.Connection]
+ The connections to process.
+ subchain_map: dict[tuple[str, int], str]
+ The mapping from chain, residue index to subchain name.
+ entities: dict[str, gemmi.Entity]
+ The entities in the structure.
+
+ Returns
+ -------
+ set
+ The covalent ligand subchains.
+
+ """
+ # Get covalent chain ids
+ covalent_chain_ids = set()
+ for connection in connections:
+ if connection.type.name != "Covale":
+ continue
+
+ # Map to correct subchain
+ chain_1_name = connection.partner1.chain_name
+ chain_2_name = connection.partner2.chain_name
+
+ res_1_id = connection.partner1.res_id.seqid
+ res_1_id = str(res_1_id.num) + str(res_1_id.icode).strip()
+
+ res_2_id = connection.partner2.res_id.seqid
+ res_2_id = str(res_2_id.num) + str(res_2_id.icode).strip()
+
+ subchain_1 = subchain_map[(chain_1_name, res_1_id)]
+ subchain_2 = subchain_map[(chain_2_name, res_2_id)]
+
+ # If non-polymer or branched, add to set
+ entity_1 = entities[subchain_1].entity_type.name
+ entity_2 = entities[subchain_2].entity_type.name
+
+ if entity_1 in {"NonPolymer", "Branched"}:
+ covalent_chain_ids.add(subchain_1)
+ if entity_2 in {"NonPolymer", "Branched"}:
+ covalent_chain_ids.add(subchain_2)
+
+ return covalent_chain_ids
+
+
+def compute_interfaces(atom_data: np.ndarray, chain_data: np.ndarray) -> np.ndarray:
+ """Compute the chain-chain interfaces from a gemmi structure.
+
+ Parameters
+ ----------
+ atom_data : List[tuple]
+ The atom data.
+ chain_data : List[tuple]
+ The chain data.
+
+ Returns
+ -------
+ List[tuple[int, int]]
+ The interfaces.
+
+ """
+ # Compute chain_id per atom
+ chain_ids = []
+ for idx, chain in enumerate(chain_data):
+ chain_ids.extend([idx] * chain["atom_num"])
+ chain_ids = np.array(chain_ids)
+
+ # Filte to present atoms
+ coords = atom_data["coords"]
+ mask = atom_data["is_present"]
+
+ coords = coords[mask]
+ chain_ids = chain_ids[mask]
+
+ # Compute the distance matrix
+ tree = KDTree(coords, metric="euclidean")
+ query = tree.query_radius(coords, const.atom_interface_cutoff)
+
+ # Get unique chain pairs
+ interfaces = set()
+ for c1, pairs in zip(chain_ids, query):
+ chains = np.unique(chain_ids[pairs])
+ chains = chains[chains != c1]
+ interfaces.update((c1, c2) for c2 in chains)
+
+ # Get unique chain pairs
+ interfaces = [(min(i, j), max(i, j)) for i, j in interfaces]
+ interfaces = list({(int(i), int(j)) for i, j in interfaces})
+ interfaces = np.array(interfaces, dtype=Interface)
+ return interfaces
+
+
+####################################################################################################
+# PARSING
+####################################################################################################
+
+
+def parse_ccd_residue( # noqa: PLR0915, C901
+ name: str,
+ components: dict[str, Mol],
+ res_idx: int,
+ gemmi_mol: Optional[gemmi.Residue] = None,
+ is_covalent: bool = False,
+) -> Optional[ParsedResidue]:
+ """Parse an MMCIF ligand.
+
+ First tries to get the SMILES string from the RCSB.
+ Then, tries to infer atom ordering using RDKit.
+
+ Parameters
+ ----------
+ name: str
+ The name of the molecule to parse.
+ components : dict
+ The preprocessed PDB components dictionary.
+ res_idx : int
+ The residue index.
+ gemmi_mol : Optional[gemmi.Residue]
+ The PDB molecule, as a gemmi Residue object, if any.
+
+ Returns
+ -------
+ ParsedResidue, optional
+ The output ParsedResidue, if successful.
+
+ """
+ unk_chirality = const.chirality_type_ids[const.unk_chirality_type]
+ # Check if we have a PDB structure for this residue,
+ # it could be a missing residue from the sequence
+ is_present = gemmi_mol is not None
+
+ # Save original index (required for parsing connections)
+ if is_present:
+ orig_idx = gemmi_mol.seqid
+ orig_idx = str(orig_idx.num) + str(orig_idx.icode).strip()
+ else:
+ orig_idx = None
+
+ # Get reference component
+ ref_mol = components[name]
+
+ # Remove hydrogens
+ ref_mol = AllChem.RemoveHs(ref_mol, sanitize=False)
+
+ # Check if this is a single atom CCD residue
+ if ref_mol.GetNumAtoms() == 1:
+ pos = (0, 0, 0)
+ if is_present:
+ pos = (
+ gemmi_mol[0].pos.x,
+ gemmi_mol[0].pos.y,
+ gemmi_mol[0].pos.z,
+ )
+ ref_atom = ref_mol.GetAtoms()[0]
+ chirality_type = const.chirality_type_ids.get(
+ str(ref_atom.GetChiralTag()), unk_chirality
+ )
+ atom = ParsedAtom(
+ name=ref_atom.GetProp("name"),
+ element=ref_atom.GetAtomicNum(),
+ charge=ref_atom.GetFormalCharge(),
+ coords=pos,
+ conformer=(0, 0, 0),
+ is_present=is_present,
+ chirality=chirality_type,
+ )
+ unk_prot_id = const.unk_token_ids["PROTEIN"]
+ residue = ParsedResidue(
+ name=name,
+ type=unk_prot_id,
+ atoms=[atom],
+ bonds=[],
+ idx=res_idx,
+ orig_idx=orig_idx,
+ atom_center=0, # Placeholder, no center
+ atom_disto=0, # Placeholder, no center
+ is_standard=False,
+ is_present=is_present,
+ )
+ return residue
+
+ # If multi-atom, start by getting the PDB coordinates
+ pdb_pos = {}
+ if is_present:
+ # Match atoms based on names
+ for atom in gemmi_mol:
+ atom: gemmi.Atom
+ pos = (atom.pos.x, atom.pos.y, atom.pos.z)
+ pdb_pos[atom.name] = pos
+
+ # Get reference conformer coordinates
+ conformer = get_conformer(ref_mol)
+
+ # Parse each atom in order of the reference mol
+ atoms = []
+ atom_idx = 0
+ idx_map = {} # Used for bonds later
+
+ for i, atom in enumerate(ref_mol.GetAtoms()):
+ # Get atom name, charge, element and reference coordinates
+ atom_name = atom.GetProp("name")
+ charge = atom.GetFormalCharge()
+ element = atom.GetAtomicNum()
+ ref_coords = conformer.GetAtomPosition(atom.GetIdx())
+ ref_coords = (ref_coords.x, ref_coords.y, ref_coords.z)
+ chirality_type = const.chirality_type_ids.get(
+ str(atom.GetChiralTag()), unk_chirality
+ )
+
+ # If the atom is a leaving atom, skip if not in the PDB and is_covalent
+ if (
+ int(atom.GetProp("leaving_atom")) == 1
+ and is_covalent
+ and (atom_name not in pdb_pos)
+ ):
+ continue
+
+ # Get PDB coordinates, if any
+ coords = pdb_pos.get(atom_name)
+ if coords is None:
+ atom_is_present = False
+ coords = (0, 0, 0)
+ else:
+ atom_is_present = True
+
+ # Add atom to list
+ atoms.append(
+ ParsedAtom(
+ name=atom_name,
+ element=element,
+ charge=charge,
+ coords=coords,
+ conformer=ref_coords,
+ is_present=atom_is_present,
+ chirality=chirality_type,
+ )
+ )
+ idx_map[i] = atom_idx
+ atom_idx += 1
+
+ # Load bonds
+ bonds = []
+ unk_bond = const.bond_type_ids[const.unk_bond_type]
+ for bond in ref_mol.GetBonds():
+ idx_1 = bond.GetBeginAtomIdx()
+ idx_2 = bond.GetEndAtomIdx()
+
+ # Skip bonds with atoms ignored
+ if (idx_1 not in idx_map) or (idx_2 not in idx_map):
+ continue
+
+ idx_1 = idx_map[idx_1]
+ idx_2 = idx_map[idx_2]
+ start = min(idx_1, idx_2)
+ end = max(idx_1, idx_2)
+ bond_type = bond.GetBondType().name
+ bond_type = const.bond_type_ids.get(bond_type, unk_bond)
+ bonds.append(ParsedBond(start, end, bond_type))
+
+ unk_prot_id = const.unk_token_ids["PROTEIN"]
+ return ParsedResidue(
+ name=name,
+ type=unk_prot_id,
+ atoms=atoms,
+ bonds=bonds,
+ idx=res_idx,
+ atom_center=0,
+ atom_disto=0,
+ orig_idx=orig_idx,
+ is_standard=False,
+ is_present=is_present,
+ )
+
+
+def parse_polymer( # noqa: C901, PLR0915, PLR0912
+ polymer: gemmi.ResidueSpan,
+ polymer_type: gemmi.PolymerType,
+ sequence: list[str],
+ chain_id: str,
+ entity: str,
+ components: dict[str, Mol],
+) -> Optional[ParsedChain]:
+ """Process a gemmi Polymer into a chain object.
+
+ Performs alignment of the full sequence to the polymer
+ residues. Loads coordinates and masks for the atoms in
+ the polymer, following the ordering in const.atom_order.
+
+ Parameters
+ ----------
+ polymer : gemmi.ResidueSpan
+ The polymer to process.
+ polymer_type : gemmi.PolymerType
+ The polymer type.
+ sequence : str
+ The full sequence of the polymer.
+ chain_id : str
+ The chain identifier.
+ entity : str
+ The entity name.
+ components : dict[str, Mol]
+ The preprocessed PDB components dictionary.
+
+ Returns
+ -------
+ ParsedChain, optional
+ The output chain, if successful.
+
+ Raises
+ ------
+ ValueError
+ If the alignment fails.
+
+ """
+ # Get unknown chirality token
+ unk_chirality = const.chirality_type_ids[const.unk_chirality_type]
+
+ # Ignore microheterogenities (pick first)
+ sequence = [gemmi.Entity.first_mon(item) for item in sequence]
+
+ # Align full sequence to polymer residues
+ # This is a simple way to handle all the different numbering schemes
+ result = gemmi.align_sequence_to_polymer(
+ sequence,
+ polymer,
+ polymer_type,
+ gemmi.AlignmentScoring(),
+ )
+
+ # Get coordinates and masks
+ i = 0
+ ref_res = set(const.tokens)
+ parsed = []
+ for j, match in enumerate(result.match_string):
+ # Get residue name from sequence
+ res_name = sequence[j]
+
+ # Check if we have a match in the structure
+ res = None
+ name_to_atom = {}
+
+ if match == "|":
+ # Get pdb residue
+ res = polymer[i]
+ name_to_atom = {a.name.upper(): a for a in res}
+
+ # Double check the match
+ if res.name != res_name:
+ msg = "Alignment mismatch!"
+ raise ValueError(msg)
+
+ # Increment polymer index
+ i += 1
+
+ # Map MSE to MET, put the selenium atom in the sulphur column
+ if res_name == "MSE":
+ res_name = "MET"
+ if "SE" in name_to_atom:
+ name_to_atom["SD"] = name_to_atom["SE"]
+
+ # Handle non-standard residues
+ elif res_name not in ref_res:
+ residue = parse_ccd_residue(
+ name=res_name,
+ components=components,
+ res_idx=j,
+ gemmi_mol=res,
+ is_covalent=True,
+ )
+ parsed.append(residue)
+ continue
+
+ # Load regular residues
+ ref_mol = components[res_name]
+ ref_mol = AllChem.RemoveHs(ref_mol, sanitize=False)
+ ref_conformer = get_conformer(ref_mol)
+
+ # Only use reference atoms set in constants
+ ref_name_to_atom = {a.GetProp("name"): a for a in ref_mol.GetAtoms()}
+ ref_atoms = [ref_name_to_atom[a] for a in const.ref_atoms[res_name]]
+
+ # Iterate, always in the same order
+ atoms: list[ParsedAtom] = []
+
+ for ref_atom in ref_atoms:
+ # Get atom name
+ atom_name = ref_atom.GetProp("name")
+ idx = ref_atom.GetIdx()
+
+ # Get conformer coordinates
+ ref_coords = ref_conformer.GetAtomPosition(idx)
+ ref_coords = (ref_coords.x, ref_coords.y, ref_coords.z)
+
+ # Get coordinated from PDB
+ if atom_name in name_to_atom:
+ atom = name_to_atom[atom_name]
+ atom_is_present = True
+ coords = (atom.pos.x, atom.pos.y, atom.pos.z)
+ else:
+ atom_is_present = False
+ coords = (0, 0, 0)
+
+ # Add atom to list
+ atoms.append(
+ ParsedAtom(
+ name=atom_name,
+ element=ref_atom.GetAtomicNum(),
+ charge=ref_atom.GetFormalCharge(),
+ coords=coords,
+ conformer=ref_coords,
+ is_present=atom_is_present,
+ chirality=const.chirality_type_ids.get(
+ str(ref_atom.GetChiralTag()), unk_chirality
+ ),
+ )
+ )
+
+ # Fix naming errors in arginine residues where NH2 is
+ # incorrectly assigned to be closer to CD than NH1
+ if (res is not None) and (res_name == "ARG"):
+ ref_atoms: list[str] = const.ref_atoms["ARG"]
+ cd = atoms[ref_atoms.index("CD")]
+ nh1 = atoms[ref_atoms.index("NH1")]
+ nh2 = atoms[ref_atoms.index("NH2")]
+
+ cd_coords = np.array(cd.coords)
+ nh1_coords = np.array(nh1.coords)
+ nh2_coords = np.array(nh2.coords)
+
+ if all(atom.is_present for atom in (cd, nh1, nh2)) and (
+ np.linalg.norm(nh1_coords - cd_coords)
+ > np.linalg.norm(nh2_coords - cd_coords)
+ ):
+ atoms[ref_atoms.index("NH1")] = replace(nh1, coords=nh2.coords)
+ atoms[ref_atoms.index("NH2")] = replace(nh2, coords=nh1.coords)
+
+ # Add residue to parsed list
+ if res is not None:
+ orig_idx = res.seqid
+ orig_idx = str(orig_idx.num) + str(orig_idx.icode).strip()
+ else:
+ orig_idx = None
+
+ atom_center = const.res_to_center_atom_id[res_name]
+ atom_disto = const.res_to_disto_atom_id[res_name]
+ parsed.append(
+ ParsedResidue(
+ name=res_name,
+ type=const.token_ids[res_name],
+ atoms=atoms,
+ bonds=[],
+ idx=j,
+ atom_center=atom_center,
+ atom_disto=atom_disto,
+ is_standard=True,
+ is_present=res is not None,
+ orig_idx=orig_idx,
+ )
+ )
+
+ # Get polymer class
+ if polymer_type == gemmi.PolymerType.PeptideL:
+ chain_type = const.chain_type_ids["PROTEIN"]
+ elif polymer_type == gemmi.PolymerType.Dna:
+ chain_type = const.chain_type_ids["DNA"]
+ elif polymer_type == gemmi.PolymerType.Rna:
+ chain_type = const.chain_type_ids["RNA"]
+
+ # Return polymer object
+ return ParsedChain(
+ name=chain_id,
+ entity=entity,
+ residues=parsed,
+ type=chain_type,
+ sequence=gemmi.one_letter_code(sequence),
+ )
+
+
+def parse_connection(
+ connection: gemmi.Connection,
+ chains: list[ParsedChain],
+ subchain_map: dict[tuple[str, int], str],
+) -> ParsedConnection:
+ """Parse (covalent) connection from a gemmi Connection.
+
+ Parameters
+ ----------
+ connections : gemmi.ConnectionList
+ The connection list to parse.
+ chains : List[Chain]
+ The parsed chains.
+ subchain_map : dict[tuple[str, int], str]
+ The mapping from chain, residue index to subchain name.
+
+ Returns
+ -------
+ List[Connection]
+ The parsed connections.
+
+ """
+ # Map to correct subchains
+ chain_1_name = connection.partner1.chain_name
+ chain_2_name = connection.partner2.chain_name
+
+ res_1_id = connection.partner1.res_id.seqid
+ res_1_id = str(res_1_id.num) + str(res_1_id.icode).strip()
+
+ res_2_id = connection.partner2.res_id.seqid
+ res_2_id = str(res_2_id.num) + str(res_2_id.icode).strip()
+
+ subchain_1 = subchain_map[(chain_1_name, res_1_id)]
+ subchain_2 = subchain_map[(chain_2_name, res_2_id)]
+
+ # Get chain indices
+ chain_1 = next(chain for chain in chains if (chain.name == subchain_1))
+ chain_2 = next(chain for chain in chains if (chain.name == subchain_2))
+
+ # Get residue indices
+ res_1_idx, res_1 = next(
+ (idx, res)
+ for idx, res in enumerate(chain_1.residues)
+ if (res.orig_idx == res_1_id)
+ )
+ res_2_idx, res_2 = next(
+ (idx, res)
+ for idx, res in enumerate(chain_2.residues)
+ if (res.orig_idx == res_2_id)
+ )
+
+ # Get atom indices
+ atom_index_1 = next(
+ idx
+ for idx, atom in enumerate(res_1.atoms)
+ if atom.name == connection.partner1.atom_name
+ )
+ atom_index_2 = next(
+ idx
+ for idx, atom in enumerate(res_2.atoms)
+ if atom.name == connection.partner2.atom_name
+ )
+
+ conn = ParsedConnection(
+ chain_1=subchain_1,
+ chain_2=subchain_2,
+ residue_index_1=res_1_idx,
+ residue_index_2=res_2_idx,
+ atom_index_1=atom_index_1,
+ atom_index_2=atom_index_2,
+ )
+
+ return conn
+
+
+def parse_mmcif( # noqa: C901, PLR0915, PLR0912
+ path: str,
+ components: dict[str, Mol],
+ use_assembly: bool = True,
+) -> ParsedStructure:
+ """Parse a structure in MMCIF format.
+
+ Parameters
+ ----------
+ mmcif_file : PathLike
+ Path to the MMCIF file.
+ components: dict[str, Mol]
+ The preprocessed PDB components dictionary.
+ use_assembly: bool
+ Whether to use the first assembly.
+
+ Returns
+ -------
+ ParsedStructure
+ The parsed structure.
+
+ """
+ # Disable rdkit warnings
+ blocker = rdBase.BlockLogs() # noqa: F841
+
+ # Parse MMCIF input file
+ block = gemmi.cif.read(str(path))[0]
+
+ # Extract medatadata
+ deposit_date, release_date, revision_date = get_dates(block)
+ resolution = get_resolution(block)
+ method = get_method(block)
+
+ # Load structure object
+ structure = gemmi.make_structure_from_block(block)
+
+ # Clean up the structure
+ structure.merge_chain_parts()
+ structure.remove_waters()
+ structure.remove_hydrogens()
+ structure.remove_alternative_conformations()
+ structure.remove_empty_chains()
+
+ # Expand assembly 1
+ if use_assembly and structure.assemblies:
+ how = gemmi.HowToNameCopiedChain.AddNumber
+ assembly_name = structure.assemblies[0].name
+ structure.transform_to_assembly(assembly_name, how=how)
+
+ # Parse entities
+ # Create mapping from subchain id to entity
+ entities: dict[str, gemmi.Entity] = {}
+ entity_ids: dict[str, int] = {}
+ for entity_id, entity in enumerate(structure.entities):
+ entity: gemmi.Entity
+ if entity.entity_type.name == "Water":
+ continue
+ for subchain_id in entity.subchains:
+ entities[subchain_id] = entity
+ entity_ids[subchain_id] = entity_id
+
+ # Create mapping from chain, residue to subchains
+ # since a Connection uses the chains and not subchins
+ subchain_map = {}
+ for chain in structure[0]:
+ for residue in chain:
+ seq_id = residue.seqid
+ seq_id = str(seq_id.num) + str(seq_id.icode).strip()
+ subchain_map[(chain.name, seq_id)] = residue.subchain
+
+ # Find covalent ligands
+ covalent_chain_ids = compute_covalent_ligands(
+ connections=structure.connections,
+ subchain_map=subchain_map,
+ entities=entities,
+ )
+
+ # Parse chains
+ chains: list[ParsedChain] = []
+ chain_seqs = []
+ for raw_chain in structure[0].subchains():
+ # Check chain type
+ subchain_id = raw_chain.subchain_id()
+ entity: gemmi.Entity = entities[subchain_id]
+ entity_type = entity.entity_type.name
+
+ # Parse a polymer
+ if entity_type == "Polymer":
+ # Skip PeptideD, DnaRnaHybrid, Pna, Other
+ if entity.polymer_type.name not in {
+ "PeptideL",
+ "Dna",
+ "Rna",
+ }:
+ continue
+
+ # Add polymer if successful
+ parsed_polymer = parse_polymer(
+ polymer=raw_chain,
+ polymer_type=entity.polymer_type,
+ sequence=entity.full_sequence,
+ chain_id=subchain_id,
+ entity=entity.name,
+ components=components,
+ )
+ if parsed_polymer is not None:
+ chains.append(parsed_polymer)
+ chain_seqs.append(parsed_polymer.sequence)
+
+ # Parse a non-polymer
+ elif entity_type in {"NonPolymer", "Branched"}:
+ # Skip UNL or other missing ligands
+ if any(components.get(lig.name) is None for lig in raw_chain):
+ continue
+
+ residues = []
+ for lig_idx, ligand in enumerate(raw_chain):
+ # Check if ligand is covalent
+ if entity_type == "Branched":
+ is_covalent = True
+ else:
+ is_covalent = subchain_id in covalent_chain_ids
+
+ ligand: gemmi.Residue
+ residue = parse_ccd_residue(
+ name=ligand.name,
+ components=components,
+ res_idx=lig_idx,
+ gemmi_mol=ligand,
+ is_covalent=is_covalent,
+ )
+ residues.append(residue)
+
+ if residues:
+ chains.append(
+ ParsedChain(
+ name=subchain_id,
+ entity=entity.name,
+ residues=residues,
+ type=const.chain_type_ids["NONPOLYMER"],
+ sequence=None,
+ )
+ )
+
+ # If no chains parsed fail
+ if not chains:
+ msg = "No chains parsed!"
+ raise ValueError(msg)
+
+ # Parse covalent connections
+ connections: list[ParsedConnection] = []
+ for connection in structure.connections:
+ # Skip non-covalent connections
+ connection: gemmi.Connection
+ if connection.type.name != "Covale":
+ continue
+
+ parsed_connection = parse_connection(
+ connection=connection,
+ chains=chains,
+ subchain_map=subchain_map,
+ )
+ connections.append(parsed_connection)
+
+ # Create tables
+ atom_data = []
+ bond_data = []
+ res_data = []
+ chain_data = []
+ connection_data = []
+
+ # Convert parsed chains to tables
+ atom_idx = 0
+ res_idx = 0
+ asym_id = 0
+ sym_count = {}
+ chain_to_idx = {}
+ res_to_idx = {}
+
+ for asym_id, chain in enumerate(chains):
+ # Compute number of atoms and residues
+ res_num = len(chain.residues)
+ atom_num = sum(len(res.atoms) for res in chain.residues)
+
+ # Find all copies of this chain in the assembly
+ entity_id = entity_ids[chain.name]
+ sym_id = sym_count.get(entity_id, 0)
+ chain_data.append(
+ (
+ chain.name,
+ chain.type,
+ entity_id,
+ sym_id,
+ asym_id,
+ atom_idx,
+ atom_num,
+ res_idx,
+ res_num,
+ )
+ )
+ chain_to_idx[chain.name] = asym_id
+ sym_count[entity_id] = sym_id + 1
+
+ # Add residue, atom, bond, data
+ for i, res in enumerate(chain.residues):
+ atom_center = atom_idx + res.atom_center
+ atom_disto = atom_idx + res.atom_disto
+ res_data.append(
+ (
+ res.name,
+ res.type,
+ res.idx,
+ atom_idx,
+ len(res.atoms),
+ atom_center,
+ atom_disto,
+ res.is_standard,
+ res.is_present,
+ )
+ )
+ res_to_idx[(chain.name, i)] = (res_idx, atom_idx)
+
+ for bond in res.bonds:
+ atom_1 = atom_idx + bond.atom_1
+ atom_2 = atom_idx + bond.atom_2
+ bond_data.append((atom_1, atom_2, bond.type))
+
+ for atom in res.atoms:
+ atom_data.append(
+ (
+ convert_atom_name(atom.name),
+ atom.element,
+ atom.charge,
+ atom.coords,
+ atom.conformer,
+ atom.is_present,
+ atom.chirality,
+ )
+ )
+ atom_idx += 1
+
+ res_idx += 1
+
+ # Convert connections to tables
+ for conn in connections:
+ chain_1_idx = chain_to_idx[conn.chain_1]
+ chain_2_idx = chain_to_idx[conn.chain_2]
+ res_1_idx, atom_1_offset = res_to_idx[(conn.chain_1, conn.residue_index_1)]
+ res_2_idx, atom_2_offset = res_to_idx[(conn.chain_2, conn.residue_index_2)]
+ atom_1_idx = atom_1_offset + conn.atom_index_1
+ atom_2_idx = atom_2_offset + conn.atom_index_2
+ connection_data.append(
+ (
+ chain_1_idx,
+ chain_2_idx,
+ res_1_idx,
+ res_2_idx,
+ atom_1_idx,
+ atom_2_idx,
+ )
+ )
+
+ # Convert into datatypes
+ atoms = np.array(atom_data, dtype=Atom)
+ bonds = np.array(bond_data, dtype=Bond)
+ residues = np.array(res_data, dtype=Residue)
+ chains = np.array(chain_data, dtype=Chain)
+ connections = np.array(connection_data, dtype=Connection)
+ mask = np.ones(len(chain_data), dtype=bool)
+
+ # Compute interface chains (find chains with a heavy atom within 5A)
+ interfaces = compute_interfaces(atoms, chains)
+
+ # Return parsed structure
+ info = StructureInfo(
+ deposited=deposit_date,
+ revised=revision_date,
+ released=release_date,
+ resolution=resolution,
+ method=method,
+ num_chains=len(chains),
+ num_interfaces=len(interfaces),
+ )
+
+ data = Structure(
+ atoms=atoms,
+ bonds=bonds,
+ residues=residues,
+ chains=chains,
+ connections=connections,
+ interfaces=interfaces,
+ mask=mask,
+ )
+
+ return ParsedStructure(data=data, info=info, covalents=[])
diff --git a/forks/boltz/scripts/process/msa.py b/forks/boltz/scripts/process/msa.py
new file mode 100644
index 00000000..609f53ef
--- /dev/null
+++ b/forks/boltz/scripts/process/msa.py
@@ -0,0 +1,130 @@
+import argparse
+import multiprocessing
+from dataclasses import asdict
+from functools import partial
+from pathlib import Path
+from typing import Any
+
+import numpy as np
+from p_tqdm import p_umap
+from redis import Redis
+from tqdm import tqdm
+
+from boltz.data.parse.a3m import parse_a3m
+
+
+class Resource:
+ """A shared resource for processing."""
+
+ def __init__(self, host: str, port: int) -> None:
+ """Initialize the redis database."""
+ self._redis = Redis(host=host, port=port)
+
+ def get(self, key: str) -> Any: # noqa: ANN401
+ """Get an item from the Redis database."""
+ return self._redis.get(key)
+
+ def __getitem__(self, key: str) -> Any: # noqa: ANN401
+ """Get an item from the resource."""
+ out = self.get(key)
+ if out is None:
+ raise KeyError(key)
+ return out
+
+
+def process_msa(
+ path: Path,
+ outdir: str,
+ max_seqs: int,
+ resource: Resource,
+) -> None:
+ """Run processing in a worker thread."""
+ outdir = Path(outdir)
+ out_path = outdir / f"{path.stem}.npz"
+ if not out_path.exists():
+ msa = parse_a3m(path, resource, max_seqs)
+ np.savez_compressed(out_path, **asdict(msa))
+
+
+def process(args) -> None:
+ """Run the data processing task."""
+ # Create output directory
+ args.outdir.mkdir(parents=True, exist_ok=True)
+
+ # Load the resource
+ resource = Resource(host=args.redis_host, port=args.redis_port)
+
+ # Get data points
+ print("Fetching data...")
+ data = list(args.msadir.rglob("*.a3m*"))
+ print(f"Found {len(data)} MSA's.")
+
+ # Check if we can run in parallel
+ max_processes = multiprocessing.cpu_count()
+ num_processes = max(1, min(args.num_processes, max_processes, len(data)))
+ parallel = num_processes > 1
+
+ # Run processing
+ if parallel:
+ # Create processing function
+ fn = partial(
+ process_msa,
+ outdir=args.outdir,
+ max_seqs=args.max_seqs,
+ resource=resource,
+ )
+
+ # Run in parallel
+ p_umap(fn, data, num_cpus=num_processes)
+
+ else:
+ # Run in serial
+ for path in tqdm(data):
+ process_msa(
+ path,
+ outdir=args.outdir,
+ max_seqs=args.max_seqs,
+ resource=resource,
+ )
+
+
+if __name__ == "__main__":
+ parser = argparse.ArgumentParser(description="Process MSA data.")
+ parser.add_argument(
+ "--msadir",
+ type=Path,
+ required=True,
+ help="The MSA data directory.",
+ )
+ parser.add_argument(
+ "--outdir",
+ type=Path,
+ default="data",
+ help="The output directory.",
+ )
+ parser.add_argument(
+ "--num-processes",
+ type=int,
+ default=multiprocessing.cpu_count(),
+ help="The number of processes.",
+ )
+ parser.add_argument(
+ "--redis-host",
+ type=str,
+ default="localhost",
+ help="The Redis host.",
+ )
+ parser.add_argument(
+ "--redis-port",
+ type=int,
+ default=7777,
+ help="The Redis port.",
+ )
+ parser.add_argument(
+ "--max-seqs",
+ type=int,
+ default=16384,
+ help="The maximum number of sequences.",
+ )
+ args = parser.parse_args()
+ process(args)
diff --git a/forks/boltz/scripts/process/rcsb.py b/forks/boltz/scripts/process/rcsb.py
new file mode 100644
index 00000000..ee0d7a98
--- /dev/null
+++ b/forks/boltz/scripts/process/rcsb.py
@@ -0,0 +1,359 @@
+import argparse
+import json
+import multiprocessing
+import pickle
+import traceback
+from dataclasses import asdict, dataclass, replace
+from functools import partial
+from pathlib import Path
+from typing import Any, Optional
+
+import numpy as np
+import rdkit
+from mmcif import parse_mmcif
+from p_tqdm import p_umap
+from redis import Redis
+from tqdm import tqdm
+
+from boltz.data.filter.static.filter import StaticFilter
+from boltz.data.filter.static.ligand import ExcludedLigands
+from boltz.data.filter.static.polymer import (
+ ClashingChainsFilter,
+ ConsecutiveCA,
+ MinimumLengthFilter,
+ UnknownFilter,
+)
+from boltz.data.types import ChainInfo, InterfaceInfo, Record, Target
+
+
+@dataclass(frozen=True, slots=True)
+class PDB:
+ """A raw MMCIF PDB file."""
+
+ id: str
+ path: str
+
+
+class Resource:
+ """A shared resource for processing."""
+
+ def __init__(self, host: str, port: int) -> None:
+ """Initialize the redis database."""
+ self._redis = Redis(host=host, port=port)
+
+ def get(self, key: str) -> Any: # noqa: ANN401
+ """Get an item from the Redis database."""
+ value = self._redis.get(key)
+ if value is not None:
+ value = pickle.loads(value) # noqa: S301
+ return value
+
+ def __getitem__(self, key: str) -> Any: # noqa: ANN401
+ """Get an item from the resource."""
+ out = self.get(key)
+ if out is None:
+ raise KeyError(key)
+ return out
+
+
+def fetch(datadir: Path, max_file_size: Optional[int] = None) -> list[PDB]:
+ """Fetch the PDB files."""
+ data = []
+ excluded = 0
+ for file in datadir.rglob("*.cif*"):
+ # The clustering file is annotated by pdb_entity id
+ pdb_id = str(file.stem).lower()
+
+ # Check file size and skip if too large
+ if max_file_size is not None and (file.stat().st_size > max_file_size):
+ excluded += 1
+ continue
+
+ # Create the target
+ target = PDB(id=pdb_id, path=str(file))
+ data.append(target)
+
+ print(f"Excluded {excluded} files due to size.") # noqa: T201
+ return data
+
+
+def finalize(outdir: Path) -> None:
+ """Run post-processing in main thread.
+
+ Parameters
+ ----------
+ outdir : Path
+ The output directory.
+
+ """
+ # Group records into a manifest
+ records_dir = outdir / "records"
+
+ failed_count = 0
+ records = []
+ for record in records_dir.iterdir():
+ path = record
+ try:
+ with path.open("r") as f:
+ records.append(json.load(f))
+ except: # noqa: E722
+ failed_count += 1
+ print(f"Failed to parse {record}") # noqa: T201
+ if failed_count > 0:
+ print(f"Failed to parse {failed_count} entries.") # noqa: T201
+ else:
+ print("All entries parsed successfully.")
+
+ # Save manifest
+ outpath = outdir / "manifest.json"
+ with outpath.open("w") as f:
+ json.dump(records, f)
+
+
+def parse(data: PDB, resource: Resource, clusters: dict) -> Target:
+ """Process a structure.
+
+ Parameters
+ ----------
+ data : PDB
+ The raw input data.
+ resource: Resource
+ The shared resource.
+
+ Returns
+ -------
+ Target
+ The processed data.
+
+ """
+ # Get the PDB id
+ pdb_id = data.id.lower()
+
+ # Parse structure
+ parsed = parse_mmcif(data.path, resource)
+ structure = parsed.data
+ structure_info = parsed.info
+
+ # Create chain metadata
+ chain_info = []
+ for i, chain in enumerate(structure.chains):
+ key = f"{pdb_id}_{chain['entity_id']}"
+ chain_info.append(
+ ChainInfo(
+ chain_id=i,
+ chain_name=chain["name"],
+ msa_id="", # FIX
+ mol_type=int(chain["mol_type"]),
+ cluster_id=clusters.get(key, -1),
+ num_residues=int(chain["res_num"]),
+ )
+ )
+
+ # Get interface metadata
+ interface_info = []
+ for interface in structure.interfaces:
+ chain_1 = int(interface["chain_1"])
+ chain_2 = int(interface["chain_2"])
+ interface_info.append(
+ InterfaceInfo(
+ chain_1=chain_1,
+ chain_2=chain_2,
+ )
+ )
+
+ # Create record
+ record = Record(
+ id=data.id,
+ structure=structure_info,
+ chains=chain_info,
+ interfaces=interface_info,
+ )
+
+ return Target(structure=structure, record=record)
+
+
+def process_structure(
+ data: PDB,
+ resource: Resource,
+ outdir: Path,
+ filters: list[StaticFilter],
+ clusters: dict,
+) -> None:
+ """Process a target.
+
+ Parameters
+ ----------
+ item : PDB
+ The raw input data.
+ resource: Resource
+ The shared resource.
+ outdir : Path
+ The output directory.
+
+ """
+ # Check if we need to process
+ struct_path = outdir / "structures" / f"{data.id}.npz"
+ record_path = outdir / "records" / f"{data.id}.json"
+
+ if struct_path.exists() and record_path.exists():
+ return
+
+ try:
+ # Parse the target
+ target: Target = parse(data, resource, clusters)
+ structure = target.structure
+
+ # Apply the filters
+ mask = structure.mask
+ if filters is not None:
+ for f in filters:
+ filter_mask = f.filter(structure)
+ mask = mask & filter_mask
+ except Exception: # noqa: BLE001
+ traceback.print_exc()
+ print(f"Failed to parse {data.id}")
+ return
+
+ # Replace chains and interfaces
+ chains = []
+ for i, chain in enumerate(target.record.chains):
+ chains.append(replace(chain, valid=bool(mask[i])))
+
+ interfaces = []
+ for interface in target.record.interfaces:
+ chain_1 = bool(mask[interface.chain_1])
+ chain_2 = bool(mask[interface.chain_2])
+ interfaces.append(replace(interface, valid=(chain_1 and chain_2)))
+
+ # Replace structure and record
+ structure = replace(structure, mask=mask)
+ record = replace(target.record, chains=chains, interfaces=interfaces)
+ target = replace(target, structure=structure, record=record)
+
+ # Dump structure
+ np.savez_compressed(struct_path, **asdict(structure))
+
+ # Dump record
+ with record_path.open("w") as f:
+ json.dump(asdict(record), f)
+
+
+def process(args) -> None:
+ """Run the data processing task."""
+ # Create output directory
+ args.outdir.mkdir(parents=True, exist_ok=True)
+
+ # Create output directories
+ records_dir = args.outdir / "records"
+ records_dir.mkdir(parents=True, exist_ok=True)
+
+ structure_dir = args.outdir / "structures"
+ structure_dir.mkdir(parents=True, exist_ok=True)
+
+ # Load clusters
+ with Path(args.clusters).open("r") as f:
+ clusters: dict[str, str] = json.load(f)
+ clusters = {k.lower(): v.lower() for k, v in clusters.items()}
+
+ # Load filters
+ filters = [
+ ExcludedLigands(),
+ MinimumLengthFilter(min_len=4, max_len=5000),
+ UnknownFilter(),
+ ConsecutiveCA(max_dist=10.0),
+ ClashingChainsFilter(freq=0.3, dist=1.7),
+ ]
+
+ # Set default pickle properties
+ pickle_option = rdkit.Chem.PropertyPickleOptions.AllProps
+ rdkit.Chem.SetDefaultPickleProperties(pickle_option)
+
+ # Load shared data from redis
+ resource = Resource(host=args.redis_host, port=args.redis_port)
+
+ # Get data points
+ print("Fetching data...")
+ data = fetch(args.datadir)
+
+ # Check if we can run in parallel
+ max_processes = multiprocessing.cpu_count()
+ num_processes = max(1, min(args.num_processes, max_processes, len(data)))
+ parallel = num_processes > 1
+
+ # Run processing
+ print("Processing data...")
+ if parallel:
+ # Create processing function
+ fn = partial(
+ process_structure,
+ resource=resource,
+ outdir=args.outdir,
+ clusters=clusters,
+ filters=filters,
+ )
+ # Run processing in parallel
+ p_umap(fn, data, num_cpus=num_processes)
+ else:
+ for item in tqdm(data):
+ process_structure(
+ item,
+ resource=resource,
+ outdir=args.outdir,
+ clusters=clusters,
+ filters=filters,
+ )
+
+ # Finalize
+ finalize(args.outdir)
+
+
+if __name__ == "__main__":
+ parser = argparse.ArgumentParser(description="Process MSA data.")
+ parser.add_argument(
+ "--datadir",
+ type=Path,
+ required=True,
+ help="The data containing the MMCIF files.",
+ )
+ parser.add_argument(
+ "--clusters",
+ type=Path,
+ required=True,
+ help="Path to the cluster file.",
+ )
+ parser.add_argument(
+ "--outdir",
+ type=Path,
+ default="data",
+ help="The output directory.",
+ )
+ parser.add_argument(
+ "--num-processes",
+ type=int,
+ default=multiprocessing.cpu_count(),
+ help="The number of processes.",
+ )
+ parser.add_argument(
+ "--redis-host",
+ type=str,
+ default="localhost",
+ help="The Redis host.",
+ )
+ parser.add_argument(
+ "--redis-port",
+ type=int,
+ default=7777,
+ help="The Redis port.",
+ )
+ parser.add_argument(
+ "--use-assembly",
+ action="store_true",
+ help="Whether to use assembly 1.",
+ )
+ parser.add_argument(
+ "--max-file-size",
+ type=int,
+ default=None,
+ )
+ args = parser.parse_args()
+ process(args)
diff --git a/forks/boltz/scripts/process/requirements.txt b/forks/boltz/scripts/process/requirements.txt
new file mode 100644
index 00000000..d4f7611a
--- /dev/null
+++ b/forks/boltz/scripts/process/requirements.txt
@@ -0,0 +1,5 @@
+gemmi
+pdbeccdutils
+redis
+scikit-learn
+p_tqdm
\ No newline at end of file
diff --git a/forks/boltz/scripts/train/README.md b/forks/boltz/scripts/train/README.md
new file mode 100644
index 00000000..ed00f22b
--- /dev/null
+++ b/forks/boltz/scripts/train/README.md
@@ -0,0 +1 @@
+Please see our [training instructions](../../docs/training.md).
\ No newline at end of file
diff --git a/forks/boltz/scripts/train/assets/casp15_ids.txt b/forks/boltz/scripts/train/assets/casp15_ids.txt
new file mode 100644
index 00000000..b3464ddd
--- /dev/null
+++ b/forks/boltz/scripts/train/assets/casp15_ids.txt
@@ -0,0 +1,72 @@
+T1112
+T1118v1
+T1154
+T1137s1
+T1188
+T1157s1
+T1137s6
+R1117
+H1106
+T1106s2
+R1149
+T1158
+T1137s2
+T1145
+T1121
+T1123
+T1113
+R1156
+T1114s1
+T1183
+R1107
+T1137s7
+T1124
+T1178
+T1147
+R1128
+T1161
+R1108
+T1194
+T1185s2
+T1176
+T1158v3
+T1137s4
+T1160
+T1120
+H1185
+T1134s1
+T1119
+H1151
+T1137s8
+T1133
+T1187
+H1157
+T1122
+T1104
+T1158v2
+T1137s5
+T1129s2
+T1174
+T1157s2
+T1155
+T1158v4
+T1152
+T1137s9
+T1134s2
+T1125
+R1116
+H1134
+R1136
+T1159
+T1137s3
+T1185s1
+T1179
+T1106s1
+T1132
+T1185s4
+T1114s3
+T1114s2
+T1151s2
+T1158v1
+R1117v2
+T1173
diff --git a/forks/boltz/scripts/train/assets/test_ids.txt b/forks/boltz/scripts/train/assets/test_ids.txt
new file mode 100644
index 00000000..2bb230da
--- /dev/null
+++ b/forks/boltz/scripts/train/assets/test_ids.txt
@@ -0,0 +1,550 @@
+8BZ4
+8URN
+7U71
+7Z64
+7Y3Z
+8SOT
+8GH8
+8IIB
+7U08
+8EB5
+8G49
+8K7Y
+7QQD
+8EIL
+8JQE
+8V1K
+7ZRZ
+7YN2
+8D40
+8RXO
+8SXS
+7UDL
+8ADD
+7Z3I
+7YUK
+7XWY
+8F9Y
+8WO7
+8C27
+8I3J
+8HVC
+8SXU
+8K1I
+8FTV
+8ERC
+8DVQ
+8DTQ
+8J12
+8D0P
+8POG
+8HN0
+7QPK
+8AGR
+8GXR
+8K7X
+8BL6
+8HAW
+8SRO
+8HHM
+8C26
+7SPQ
+8SME
+7XGV
+8GTY
+8Q42
+8BRY
+8HDV
+8B3Z
+7XNJ
+8EEL
+8IOI
+8Q70
+8Y4U
+8ANT
+8IUB
+8D49
+8CPQ
+8BAT
+8E2B
+8IWP
+8IJT
+7Y01
+8CJG
+8HML
+8WU2
+8VRM
+8J1J
+8DAJ
+8SUT
+8PTJ
+8IVZ
+8SDZ
+7YDQ
+8JU7
+8K34
+8B6Q
+8F7N
+8IBZ
+7WOI
+8R7D
+8T65
+8IQC
+8SIU
+8QK8
+8HIG
+7Y43
+8IN8
+8IBW
+8GOY
+7ZAO
+8J9G
+7ZCA
+8HIO
+8EFZ
+8IQ8
+8OQ0
+8HHL
+7XMW
+8GI1
+8AYR
+7ZCB
+8BRD
+8IN6
+8I3F
+8HIU
+8ER5
+8WIL
+7YPR
+8UA2
+8BW6
+8IL8
+8J3R
+8K1F
+8OHI
+8WCT
+8AN0
+8BDQ
+7FCT
+8J69
+8HTX
+8PE3
+8K5U
+8AXT
+8PSO
+8JHR
+8GY0
+8QCW
+8K3D
+8P6J
+8J0Q
+7XS3
+8DHJ
+8EIN
+7WKP
+8GAQ
+7WRN
+8AHD
+7SC4
+8B3E
+8AAS
+8UZ8
+8Q1K
+8K5K
+8B45
+8PT7
+7ZPN
+8UQ9
+8TJG
+8TN8
+8B2E
+7XFZ
+8FW7
+8B3W
+7T4W
+8SVA
+7YL4
+8GLD
+8OEI
+8GMX
+8OWF
+8FNR
+8IRQ
+8JDG
+7UXA
+8TKA
+7YH1
+8HUZ
+8TA2
+8E5D
+7YUN
+7UOI
+7WMY
+8AA9
+8ISZ
+8EXA
+8E7F
+8B2S
+8TP8
+8GSY
+7XRX
+8SY3
+8CIL
+8WBR
+7XF1
+7YPO
+8AXF
+7QNL
+8OYY
+7R1N
+8H5S
+8B6U
+8IBX
+8Q43
+8OW8
+7XSG
+8U0M
+8IOO
+8HR5
+8BVK
+8P0C
+7TL6
+8J48
+8S0U
+8K8A
+8G53
+7XYO
+8POF
+8U1K
+8HF2
+8K4L
+8JAH
+8KGZ
+8BNB
+7UG2
+8A0A
+8Q3Z
+8XBI
+8JNM
+8GPS
+8K1R
+8Q66
+7YLQ
+7YNX
+8IMD
+7Y8H
+8OXU
+8BVE
+8B4E
+8V14
+7R5I
+8IR2
+8UK7
+8EBB
+7XCC
+8AEP
+7YDW
+8XX9
+7VS6
+8K3F
+8CQM
+7XH4
+8BH9
+7VXT
+8SM9
+8HGU
+8PSQ
+8SSU
+8VXA
+8GSX
+8GHZ
+8BJ3
+8C9V
+8T66
+7XPC
+8RH3
+8CMQ
+8AGG
+8ERM
+8P6M
+8BUX
+7S2J
+8G32
+8AXJ
+8CID
+8CPK
+8P5Q
+8HP8
+7YUJ
+8PT2
+7YK3
+7YYG
+8ABV
+7XL7
+7YLZ
+8JWS
+8IW5
+8SM6
+8BBZ
+8EOV
+8PXC
+7UWV
+8A9N
+7YH5
+8DEO
+7X2X
+8W7P
+8B5W
+8CIH
+8RB4
+8HLG
+8J8H
+8UA5
+7YKM
+8S9W
+7YPD
+8GA6
+7YPQ
+8X7X
+8HI8
+8H7A
+8C4D
+8XAT
+8W8S
+8HM4
+8H3Z
+7W91
+8GPP
+8TNM
+7YSI
+8OML
+8BBR
+7YOJ
+8JZX
+8I3X
+8AU6
+8ITO
+7SFY
+8B6P
+7Y8S
+8ESL
+8DSP
+8CLZ
+8F72
+8QLD
+8K86
+8G8E
+8QDO
+8ANU
+8PT6
+8F5D
+8DQ6
+8IFK
+8OJN
+8SSC
+7QRR
+8E55
+7TPU
+7UQU
+8HFP
+7XGT
+8A39
+8CB2
+8ACR
+8G5S
+7TZL
+8T4R
+8H18
+7UI4
+8Q41
+8K76
+7WUY
+8VXC
+8GYG
+8IMS
+8IKS
+8X51
+7Y7O
+8PX4
+8BF8
+7XMJ
+8GDW
+7YTU
+8CH4
+7XHZ
+7YH4
+8PSN
+8A16
+8FBJ
+7Y9G
+8JI2
+7YR9
+8SW0
+8A90
+8X6V
+8H8P
+7WJU
+8PSS
+8HL8
+8FJD
+8PM4
+7UK8
+8DX0
+8PHB
+8FBN
+8FXF
+8GKH
+8ENR
+8PTH
+8CBV
+8GKV
+8CQO
+8OK3
+8GSR
+8TPK
+8H1J
+8QFL
+8CHW
+7V34
+8HE2
+7ZIE
+8A50
+7Z8E
+8ILL
+7WWC
+7XVI
+8Q2A
+8HNO
+8PR6
+7XCA
+7XGS
+8H55
+8FJE
+7UNH
+8AY2
+8ARD
+8HBR
+8EWG
+8D4A
+8FIT
+8E5E
+8PMU
+8F5G
+8AMU
+8CPN
+7QPL
+8EHN
+8SQU
+8F70
+8FX9
+7UR2
+8T1M
+7ZDS
+7YH2
+8B6A
+8CHX
+8G0N
+8GY4
+7YKG
+8BH8
+8BVI
+7XF2
+8BFY
+8IA3
+8JW3
+8OQJ
+8TFS
+7Y1S
+8HBB
+8AF9
+8IP1
+7XZ3
+8T0P
+7Y16
+8BRP
+8JNX
+8JP0
+8EC3
+8PZH
+7URP
+8B4D
+8JFR
+8GYR
+7XFS
+8SMQ
+7WNH
+8H0L
+8OWI
+8HFC
+7X6G
+8FKL
+8PAG
+8UPI
+8D4B
+8BCK
+8JFU
+8FUQ
+8IF8
+8PAQ
+8HDU
+8W9O
+8ACA
+7YIA
+7ZFR
+7Y9A
+8TTO
+7YFX
+8B2H
+8PSU
+8ACC
+8JMR
+8IHA
+7UYX
+8DWJ
+8BY5
+8EZW
+8A82
+8TVL
+8R79
+8R8A
+8AHZ
+8AYV
+8JHU
+8Q44
+8ARE
+8OLJ
+7Y95
+7XP0
+8EX9
+8BID
+8Q40
+7QSJ
+7UBA
+7XFU
+8OU1
+8G2V
+8YA7
+8GMZ
+8T8L
+8CK0
+7Y4H
+8IOM
+7ZLQ
+8BZ2
+8B4C
+8DZJ
+8CEG
+8IBY
+8T3J
+8IVI
+8ITN
+8CR7
+8TGH
+8OKH
+7UI8
+8EHT
+8ADC
+8T4C
+7XBJ
+8CLU
+7QA1
diff --git a/forks/boltz/scripts/train/assets/validation_ids.txt b/forks/boltz/scripts/train/assets/validation_ids.txt
new file mode 100644
index 00000000..13f5bb93
--- /dev/null
+++ b/forks/boltz/scripts/train/assets/validation_ids.txt
@@ -0,0 +1,552 @@
+7UTN
+7F9H
+7TZV
+7ZHH
+7SOV
+7EOF
+7R8H
+8AW3
+7F2F
+8BAO
+7BCB
+7D8T
+7D3T
+7BHY
+7YZ7
+8DC2
+7SOW
+8CTL
+7SOS
+7V6W
+7Z55
+7NQF
+7VTN
+7KSP
+7BJQ
+7YZC
+7Y3L
+7TDX
+7R8I
+7OYK
+7TZ1
+7KIJ
+7T8K
+7KII
+7YZA
+7VP4
+7KIK
+7M5W
+7Q94
+7BCA
+7YZB
+7OG0
+7VTI
+7SOP
+7S03
+7YZG
+7TXC
+7VP5
+7Y3I
+7TDW
+8B0R
+7R8G
+7FEF
+7VP1
+7VP3
+7RGU
+7DV2
+7YZD
+7OFZ
+7Y3K
+7TEC
+7WQ5
+7VP2
+7EDB
+7VP7
+7PDV
+7XHT
+7R6R
+8CSH
+8CSZ
+7V9O
+7Q1C
+8EDC
+7PWI
+7FI1
+7ESI
+7F0Y
+7EYR
+7ZVA
+7WEG
+7E4N
+7U5Q
+7FAV
+7LJ2
+7S6F
+7B3N
+7V4P
+7AJO
+7WH1
+8DQP
+7STT
+7VQ7
+7E4J
+7RIS
+7FH8
+7BMW
+7RD0
+7V54
+7LKC
+7OU1
+7QOD
+7PX1
+7EBY
+7U1V
+7PLP
+7T8N
+7SJK
+7RGB
+7TEM
+7UG9
+7B7A
+7TM2
+7Z74
+7PCM
+7V8G
+7EUU
+7VTL
+7ZEI
+7ZC0
+7DZ9
+8B2M
+7NE9
+7ALV
+7M96
+7O6T
+7SKO
+7Z2V
+7OWX
+7SHW
+7TNI
+7ZQY
+7MDF
+7EXR
+7W6B
+7EQF
+7WWO
+7FBW
+8EHE
+7CLE
+7T80
+7WMV
+7SMG
+7WSJ
+7DBU
+7VHY
+7W5F
+7SHG
+7VU3
+7ATH
+7FGZ
+7ADS
+7REO
+7T7H
+7X0N
+7TCU
+7SKH
+7EF6
+7TBV
+7B29
+7VO5
+7TM1
+7QLD
+7BB9
+7SZ8
+7RLM
+7WWP
+7NBV
+7PLD
+7DNM
+7SFZ
+7EAW
+7QNQ
+7SZX
+7U2S
+7WZX
+7TYG
+7QCE
+7DCN
+7WJL
+7VV6
+7TJ4
+7VI8
+8AKP
+7WAO
+7N7V
+7EYO
+7VTD
+7VEG
+7QY5
+7ELV
+7P0J
+7YX8
+7U4H
+7TBD
+7WME
+7RI3
+7TOH
+7ZVM
+7PUL
+7VBO
+7DM0
+7XN9
+7ALY
+7LTB
+8A28
+7UBZ
+8DTE
+7TA2
+7QST
+7AN1
+7FIB
+8BAL
+7TMJ
+7REV
+7PZJ
+7T9X
+7SUU
+7KJQ
+7V6P
+7QA3
+7ULC
+7Y3X
+7TMU
+7OA7
+7PO9
+7Q20
+8H2C
+7VW1
+7VLJ
+8EP4
+7P57
+7QUL
+7ZQE
+7UJU
+7WG1
+7DMK
+7Y8X
+7EHG
+7W13
+7NL4
+7R4J
+7AOV
+7RFT
+7VUF
+7F72
+8DSR
+7MK3
+7MQQ
+7R55
+7T85
+7NCY
+7ZHL
+7E1N
+7W8F
+7PGK
+8GUN
+7P8D
+7PUK
+7N9D
+7XWN
+7ZHA
+7TVP
+7VI6
+7PW6
+7YM0
+7RWK
+8DKR
+7WGU
+7LJI
+7THW
+7OB6
+7N3Z
+7T3S
+7PAB
+7F9F
+7PPP
+7AD5
+7VGM
+7WBO
+7RWM
+7QFI
+7T91
+7ANU
+7UX0
+7USR
+7RDN
+7VW5
+7Q4T
+7W3R
+8DKQ
+7RCX
+7UOF
+7OKR
+7NX1
+6ZBS
+7VEV
+8E8U
+7WJ6
+7MP4
+7RPY
+7R5Z
+7VLM
+7SNE
+7WDW
+8E19
+7PP2
+7Z5H
+7P7I
+7LJJ
+7QPC
+7VJS
+7QOE
+7KZH
+7F6N
+7TMI
+7POH
+8DKS
+7YMO
+6S5I
+7N6O
+7LYU
+7POK
+7BLK
+7TCY
+7W19
+8B55
+7SMU
+7QFK
+7T5T
+7EPQ
+7DCK
+7S69
+6ZSV
+7ZGT
+7TJ1
+7V09
+7ZHD
+7ALL
+7P1Y
+7T71
+7MNK
+7W5Q
+7PZ2
+7QSQ
+7QI3
+7NZZ
+7Q47
+8D08
+7QH5
+7RXQ
+7F45
+8D07
+8EHC
+7PZT
+7K3C
+7ZGI
+7MC4
+7NPQ
+7VD7
+7XAN
+7FDP
+8A0K
+7TXO
+7ZB1
+7V5V
+7WWS
+7PBK
+8EBG
+7N0J
+7UMA
+7T1S
+8EHB
+7DWC
+7K6W
+7WEJ
+7LRH
+7ZCV
+7RKC
+7X8C
+7PV1
+7UGK
+7ULN
+7A66
+7R7M
+7M0Q
+7BGS
+7UPP
+7O62
+7VKK
+7L6Y
+7VG4
+7V2V
+7ETN
+7ZTB
+7AOO
+7OH2
+7E0M
+7PEG
+8CUK
+7ZP0
+7T6A
+7BTM
+7DOV
+7VVV
+7P22
+7RUO
+7E40
+7O5Y
+7XPK
+7R0K
+8D04
+7TYD
+7LSV
+7XSI
+7RTZ
+7UXR
+7QH3
+8END
+8CYK
+7MRJ
+7DJL
+7S5B
+7XUX
+7EV8
+7R6S
+7UH4
+7R9X
+7F7P
+7ACW
+7SPN
+7W70
+7Q5G
+7DXN
+7DK9
+8DT0
+7FDN
+7DGX
+7UJB
+7X4O
+7F4O
+7T9W
+8AID
+7ERQ
+7EQB
+7YDG
+7ETR
+8D27
+7OUU
+7R5Y
+7T8I
+7UZT
+7X8V
+7QLH
+7SAF
+7EN6
+8D4Y
+7ESJ
+7VWO
+7SBE
+7VYU
+7RVJ
+7FCL
+7WUO
+7WWF
+7VMT
+7SHJ
+7SKP
+7KOU
+6ZSU
+7VGW
+7X45
+8GYZ
+8BFE
+8DGL
+7Z3H
+8BD1
+8A0J
+7JRK
+7QII
+7X39
+7Y6B
+7OIY
+7SBI
+8A3I
+7NLI
+7F4U
+7TVY
+7X0O
+7VMH
+7EPN
+7WBK
+8BFJ
+7XFP
+7LXQ
+7TIL
+7O61
+8B8B
+7W2Q
+8APR
+7WZE
+7NYQ
+7RMX
+7PGE
+8F43
+7N2K
+7UXG
+7SXN
+7T5U
+7R22
+7E3T
+7PTB
+7OA8
+7X5T
+7PL7
+7SQ5
+7VBS
+8D03
+7TAE
+7T69
+7WF6
+7LBU
+8A06
+8DA2
+7QFL
+7KUW
+7X9R
+7XT3
+7RB4
+7PT5
+7RPS
+7RXU
+7TDY
+7W89
+7N9I
+7T1M
+7OBM
+7K3X
+7ZJC
+8BDP
+7V8W
+7DJK
+7W1K
+7QFG
+7DGY
+7ZTQ
+7F8A
+7NEK
+7CG9
+7KOB
+7TN7
+8DYS
+7WVR
diff --git a/forks/boltz/scripts/train/configs/confidence.yaml b/forks/boltz/scripts/train/configs/confidence.yaml
new file mode 100644
index 00000000..8ed2ed94
--- /dev/null
+++ b/forks/boltz/scripts/train/configs/confidence.yaml
@@ -0,0 +1,201 @@
+trainer:
+ accelerator: gpu
+ devices: 1
+ precision: 32
+ gradient_clip_val: 10.0
+ max_epochs: -1
+ accumulate_grad_batches: 128 # to adjust depending on the number of devices
+
+# Optional set wandb here
+# wandb:
+# name: boltz
+# project: boltz
+# entity: boltz
+
+
+output: SET_PATH_HERE
+pretrained: PATH_TO_STRUCTURE_CHECKPOINT_FILE
+resume: null
+disable_checkpoint: false
+matmul_precision: null
+save_top_k: -1
+load_confidence_from_trunk: false # should be set to true only when starting from scratch, not from a pretrained confidence model
+
+data:
+ datasets:
+ - _target_: boltz.data.module.training.DatasetConfig
+ target_dir: PATH_TO_TARGETS_DIR
+ msa_dir: PATH_TO_MSA_DIR
+ prob: 1.0
+ sampler:
+ _target_: boltz.data.sample.cluster.ClusterSampler
+ cropper:
+ _target_: boltz.data.crop.boltz.BoltzCropper
+ min_neighborhood: 0
+ max_neighborhood: 40
+ split: ./scripts/train/assets/validation_ids.txt
+
+ filters:
+ - _target_: boltz.data.filter.dynamic.size.SizeFilter
+ min_chains: 1
+ max_chains: 300
+ - _target_: boltz.data.filter.dynamic.date.DateFilter
+ date: "2021-09-30"
+ ref: released
+ - _target_: boltz.data.filter.dynamic.resolution.ResolutionFilter
+ resolution: 4.0
+
+ tokenizer:
+ _target_: boltz.data.tokenize.boltz.BoltzTokenizer
+ featurizer:
+ _target_: boltz.data.feature.featurizer.BoltzFeaturizer
+
+ symmetries: PATH_TO_SYMMETRY_FILE
+ max_tokens: 512
+ max_atoms: 4608
+ max_seqs: 2048
+ pad_to_max_tokens: true
+ pad_to_max_atoms: true
+ pad_to_max_seqs: true
+ samples_per_epoch: 100000
+ batch_size: 1
+ num_workers: 4
+ random_seed: 42
+ pin_memory: true
+ overfit: null
+ crop_validation: true
+ return_train_symmetries: true
+ return_val_symmetries: true
+ train_binder_pocket_conditioned_prop: 0.3
+ val_binder_pocket_conditioned_prop: 0.3
+ binder_pocket_cutoff: 6.0
+ binder_pocket_sampling_geometric_p: 0.3
+ min_dist: 2.0
+ max_dist: 22.0
+ num_bins: 64
+ atoms_per_window_queries: 32
+ compute_constraint_features: false
+
+model:
+ _target_: boltz.model.model.Boltz1
+ atom_s: 128
+ atom_z: 16
+ token_s: 384
+ token_z: 128
+ num_bins: 64
+ atom_feature_dim: 389
+ atoms_per_window_queries: 32
+ atoms_per_window_keys: 128
+ compile_pairformer: false
+ nucleotide_rmsd_weight: 5.0
+ ligand_rmsd_weight: 10.0
+ ema: true
+ ema_decay: 0.999
+
+ embedder_args:
+ atom_encoder_depth: 3
+ atom_encoder_heads: 4
+
+ msa_args:
+ msa_s: 64
+ msa_blocks: 4
+ msa_dropout: 0.15
+ z_dropout: 0.25
+ pairwise_head_width: 32
+ pairwise_num_heads: 4
+ activation_checkpointing: true
+ offload_to_cpu: false
+
+ pairformer_args:
+ num_blocks: 48
+ num_heads: 16
+ dropout: 0.25
+ activation_checkpointing: true
+ offload_to_cpu: false
+
+ score_model_args:
+ sigma_data: 16
+ dim_fourier: 256
+ atom_encoder_depth: 3
+ atom_encoder_heads: 4
+ token_transformer_depth: 24
+ token_transformer_heads: 16
+ atom_decoder_depth: 3
+ atom_decoder_heads: 4
+ conditioning_transition_layers: 2
+ activation_checkpointing: true
+ offload_to_cpu: false
+
+ structure_prediction_training: false
+ confidence_prediction: true
+ alpha_pae: 1
+ confidence_imitate_trunk: true
+ confidence_model_args:
+ num_dist_bins: 64
+ max_dist: 22
+ add_s_to_z_prod: true
+ add_s_input_to_s: true
+ use_s_diffusion: true
+ add_z_input_to_z: true
+
+ confidence_args:
+ num_plddt_bins: 50
+ num_pde_bins: 64
+ num_pae_bins: 64
+
+ training_args:
+ recycling_steps: 3
+ sampling_steps: 200
+ diffusion_multiplicity: 16
+ diffusion_samples: 1
+ confidence_loss_weight: 3e-3
+ diffusion_loss_weight: 4.0
+ distogram_loss_weight: 3e-2
+ adam_beta_1: 0.9
+ adam_beta_2: 0.95
+ adam_eps: 0.00000001
+ lr_scheduler: af3
+ base_lr: 0.0
+ max_lr: 0.0018
+ lr_warmup_no_steps: 1000
+ lr_start_decay_after_n_steps: 50000
+ lr_decay_every_n_steps: 50000
+ lr_decay_factor: 0.95
+ symmetry_correction: true
+ run_confidence_sequentially: false
+
+ validation_args:
+ recycling_steps: 3
+ sampling_steps: 200
+ diffusion_samples: 5
+ symmetry_correction: true
+ run_confidence_sequentially: true
+
+ diffusion_process_args:
+ sigma_min: 0.0004
+ sigma_max: 160.0
+ sigma_data: 16.0
+ rho: 7
+ P_mean: -1.2
+ P_std: 1.5
+ gamma_0: 0.8
+ gamma_min: 1.0
+ noise_scale: 1.0
+ step_scale: 1.0
+ coordinate_augmentation: true
+ alignment_reverse_diff: true
+ synchronize_sigmas: true
+ use_inference_model_cache: true
+
+ diffusion_loss_args:
+ add_smooth_lddt_loss: true
+ nucleotide_loss_weight: 5.0
+ ligand_loss_weight: 10.0
+
+ steering_args:
+ fk_steering: False
+ num_particles: 3
+ fk_lambda: 4.0
+ fk_resampling_interval: 3
+ physical_guidance_update: False
+ num_gd_steps: 16
diff --git a/forks/boltz/scripts/train/configs/full.yaml b/forks/boltz/scripts/train/configs/full.yaml
new file mode 100644
index 00000000..0c13f423
--- /dev/null
+++ b/forks/boltz/scripts/train/configs/full.yaml
@@ -0,0 +1,200 @@
+trainer:
+ accelerator: gpu
+ devices: 1
+ precision: 32
+ gradient_clip_val: 10.0
+ max_epochs: -1
+ accumulate_grad_batches: 128 # to adjust depending on the number of devices
+
+# Optional set wandb here
+# wandb:
+# name: boltz
+# project: boltz
+# entity: boltz
+
+
+output: SET_PATH_HERE
+pretrained: PATH_TO_CHECKPOINT_FILE
+resume: null
+disable_checkpoint: false
+matmul_precision: null
+save_top_k: -1
+
+data:
+ datasets:
+ - _target_: boltz.data.module.training.DatasetConfig
+ target_dir: PATH_TO_TARGETS_DIR
+ msa_dir: PATH_TO_MSA_DIR
+ prob: 1.0
+ sampler:
+ _target_: boltz.data.sample.cluster.ClusterSampler
+ cropper:
+ _target_: boltz.data.crop.boltz.BoltzCropper
+ min_neighborhood: 0
+ max_neighborhood: 40
+ split: ./scripts/train/assets/validation_ids.txt
+
+ filters:
+ - _target_: boltz.data.filter.dynamic.size.SizeFilter
+ min_chains: 1
+ max_chains: 300
+ - _target_: boltz.data.filter.dynamic.date.DateFilter
+ date: "2021-09-30"
+ ref: released
+ - _target_: boltz.data.filter.dynamic.resolution.ResolutionFilter
+ resolution: 4.0
+
+ tokenizer:
+ _target_: boltz.data.tokenize.boltz.BoltzTokenizer
+ featurizer:
+ _target_: boltz.data.feature.featurizer.BoltzFeaturizer
+
+ symmetries: PATH_TO_SYMMETRY_FILE
+ max_tokens: 512
+ max_atoms: 4608
+ max_seqs: 2048
+ pad_to_max_tokens: true
+ pad_to_max_atoms: true
+ pad_to_max_seqs: true
+ samples_per_epoch: 100000
+ batch_size: 1
+ num_workers: 4
+ random_seed: 42
+ pin_memory: true
+ overfit: null
+ crop_validation: true
+ return_train_symmetries: true
+ return_val_symmetries: true
+ train_binder_pocket_conditioned_prop: 0.3
+ val_binder_pocket_conditioned_prop: 0.3
+ binder_pocket_cutoff: 6.0
+ binder_pocket_sampling_geometric_p: 0.3
+ min_dist: 2.0
+ max_dist: 22.0
+ num_bins: 64
+ atoms_per_window_queries: 32
+ compute_constraint_features: false
+
+model:
+ _target_: boltz.model.model.Boltz1
+ atom_s: 128
+ atom_z: 16
+ token_s: 384
+ token_z: 128
+ num_bins: 64
+ atom_feature_dim: 389
+ atoms_per_window_queries: 32
+ atoms_per_window_keys: 128
+ compile_pairformer: false
+ nucleotide_rmsd_weight: 5.0
+ ligand_rmsd_weight: 10.0
+ ema: true
+ ema_decay: 0.999
+
+ embedder_args:
+ atom_encoder_depth: 3
+ atom_encoder_heads: 4
+
+ msa_args:
+ msa_s: 64
+ msa_blocks: 4
+ msa_dropout: 0.15
+ z_dropout: 0.25
+ pairwise_head_width: 32
+ pairwise_num_heads: 4
+ activation_checkpointing: true
+ offload_to_cpu: false
+
+ pairformer_args:
+ num_blocks: 48
+ num_heads: 16
+ dropout: 0.25
+ activation_checkpointing: true
+ offload_to_cpu: false
+
+ score_model_args:
+ sigma_data: 16
+ dim_fourier: 256
+ atom_encoder_depth: 3
+ atom_encoder_heads: 4
+ token_transformer_depth: 24
+ token_transformer_heads: 16
+ atom_decoder_depth: 3
+ atom_decoder_heads: 4
+ conditioning_transition_layers: 2
+ activation_checkpointing: true
+ offload_to_cpu: false
+
+ structure_prediction_training: true
+ confidence_prediction: true
+ alpha_pae: 1
+ confidence_imitate_trunk: true
+ confidence_model_args:
+ num_dist_bins: 64
+ max_dist: 22
+ add_s_to_z_prod: true
+ add_s_input_to_s: true
+ use_s_diffusion: true
+ add_z_input_to_z: true
+
+ confidence_args:
+ num_plddt_bins: 50
+ num_pde_bins: 64
+ num_pae_bins: 64
+
+ training_args:
+ recycling_steps: 3
+ sampling_steps: 200
+ diffusion_multiplicity: 16
+ diffusion_samples: 1
+ confidence_loss_weight: 3e-3
+ diffusion_loss_weight: 4.0
+ distogram_loss_weight: 3e-2
+ adam_beta_1: 0.9
+ adam_beta_2: 0.95
+ adam_eps: 0.00000001
+ lr_scheduler: af3
+ base_lr: 0.0
+ max_lr: 0.0018
+ lr_warmup_no_steps: 1000
+ lr_start_decay_after_n_steps: 50000
+ lr_decay_every_n_steps: 50000
+ lr_decay_factor: 0.95
+ symmetry_correction: true
+ run_confidence_sequentially: false
+
+ validation_args:
+ recycling_steps: 3
+ sampling_steps: 200
+ diffusion_samples: 5
+ symmetry_correction: true
+ run_confidence_sequentially: true
+
+ diffusion_process_args:
+ sigma_min: 0.0004
+ sigma_max: 160.0
+ sigma_data: 16.0
+ rho: 7
+ P_mean: -1.2
+ P_std: 1.5
+ gamma_0: 0.8
+ gamma_min: 1.0
+ noise_scale: 1.0
+ step_scale: 1.0
+ coordinate_augmentation: true
+ alignment_reverse_diff: true
+ synchronize_sigmas: true
+ use_inference_model_cache: true
+
+ diffusion_loss_args:
+ add_smooth_lddt_loss: true
+ nucleotide_loss_weight: 5.0
+ ligand_loss_weight: 10.0
+
+ steering_args:
+ fk_steering: False
+ num_particles: 3
+ fk_lambda: 4.0
+ fk_resampling_interval: 3
+ physical_guidance_update: False
+ num_gd_steps: 16
diff --git a/forks/boltz/scripts/train/configs/structure.yaml b/forks/boltz/scripts/train/configs/structure.yaml
new file mode 100644
index 00000000..6591f386
--- /dev/null
+++ b/forks/boltz/scripts/train/configs/structure.yaml
@@ -0,0 +1,194 @@
+trainer:
+ accelerator: gpu
+ devices: 1
+ precision: 32
+ gradient_clip_val: 10.0
+ max_epochs: -1
+ accumulate_grad_batches: 128 # to adjust depending on the number of devices
+
+# Optional set wandb here
+# wandb:
+# name: boltz
+# project: boltz
+# entity: boltz
+
+output: SET_PATH_HERE
+pretrained: PATH_TO_CHECKPOINT_FILE
+resume: null
+disable_checkpoint: false
+matmul_precision: null
+save_top_k: -1
+
+data:
+ datasets:
+ - _target_: boltz.data.module.training.DatasetConfig
+ target_dir: PATH_TO_TARGETS_DIR
+ msa_dir: PATH_TO_MSA_DIR
+ prob: 1.0
+ sampler:
+ _target_: boltz.data.sample.cluster.ClusterSampler
+ cropper:
+ _target_: boltz.data.crop.boltz.BoltzCropper
+ min_neighborhood: 0
+ max_neighborhood: 40
+ split: ./scripts/train/assets/validation_ids.txt
+
+ filters:
+ - _target_: boltz.data.filter.dynamic.size.SizeFilter
+ min_chains: 1
+ max_chains: 300
+ - _target_: boltz.data.filter.dynamic.date.DateFilter
+ date: "2021-09-30"
+ ref: released
+ - _target_: boltz.data.filter.dynamic.resolution.ResolutionFilter
+ resolution: 9.0
+
+ tokenizer:
+ _target_: boltz.data.tokenize.boltz.BoltzTokenizer
+ featurizer:
+ _target_: boltz.data.feature.featurizer.BoltzFeaturizer
+
+ symmetries: PATH_TO_SYMMETRY_FILE
+ max_tokens: 512
+ max_atoms: 4608
+ max_seqs: 2048
+ pad_to_max_tokens: true
+ pad_to_max_atoms: true
+ pad_to_max_seqs: true
+ samples_per_epoch: 100000
+ batch_size: 1
+ num_workers: 4
+ random_seed: 42
+ pin_memory: true
+ overfit: null
+ crop_validation: false
+ return_train_symmetries: false
+ return_val_symmetries: true
+ train_binder_pocket_conditioned_prop: 0.3
+ val_binder_pocket_conditioned_prop: 0.3
+ binder_pocket_cutoff: 6.0
+ binder_pocket_sampling_geometric_p: 0.3
+ min_dist: 2.0
+ max_dist: 22.0
+ num_bins: 64
+ atoms_per_window_queries: 32
+ compute_constraint_features: false
+
+model:
+ _target_: boltz.model.model.Boltz1
+ atom_s: 128
+ atom_z: 16
+ token_s: 384
+ token_z: 128
+ num_bins: 64
+ atom_feature_dim: 389
+ atoms_per_window_queries: 32
+ atoms_per_window_keys: 128
+ compile_pairformer: false
+ nucleotide_rmsd_weight: 5.0
+ ligand_rmsd_weight: 10.0
+ ema: true
+ ema_decay: 0.999
+
+ embedder_args:
+ atom_encoder_depth: 3
+ atom_encoder_heads: 4
+
+ msa_args:
+ msa_s: 64
+ msa_blocks: 4
+ msa_dropout: 0.15
+ z_dropout: 0.25
+ pairwise_head_width: 32
+ pairwise_num_heads: 4
+ activation_checkpointing: true
+ offload_to_cpu: false
+
+ pairformer_args:
+ num_blocks: 48
+ num_heads: 16
+ dropout: 0.25
+ activation_checkpointing: true
+ offload_to_cpu: false
+
+ score_model_args:
+ sigma_data: 16
+ dim_fourier: 256
+ atom_encoder_depth: 3
+ atom_encoder_heads: 4
+ token_transformer_depth: 24
+ token_transformer_heads: 16
+ atom_decoder_depth: 3
+ atom_decoder_heads: 4
+ conditioning_transition_layers: 2
+ activation_checkpointing: true
+ offload_to_cpu: false
+
+ confidence_prediction: false
+ confidence_model_args:
+ num_dist_bins: 64
+ max_dist: 22
+ add_s_to_z_prod: true
+ add_s_input_to_s: true
+ use_s_diffusion: true
+ add_z_input_to_z: true
+
+ confidence_args:
+ num_plddt_bins: 50
+ num_pde_bins: 64
+ num_pae_bins: 64
+
+ training_args:
+ recycling_steps: 3
+ sampling_steps: 20
+ diffusion_multiplicity: 16
+ diffusion_samples: 2
+ confidence_loss_weight: 1e-4
+ diffusion_loss_weight: 4.0
+ distogram_loss_weight: 3e-2
+ adam_beta_1: 0.9
+ adam_beta_2: 0.95
+ adam_eps: 0.00000001
+ lr_scheduler: af3
+ base_lr: 0.0
+ max_lr: 0.0018
+ lr_warmup_no_steps: 1000
+ lr_start_decay_after_n_steps: 50000
+ lr_decay_every_n_steps: 50000
+ lr_decay_factor: 0.95
+
+ validation_args:
+ recycling_steps: 3
+ sampling_steps: 200
+ diffusion_samples: 5
+ symmetry_correction: true
+ run_confidence_sequentially: false
+
+ diffusion_process_args:
+ sigma_min: 0.0004
+ sigma_max: 160.0
+ sigma_data: 16.0
+ rho: 7
+ P_mean: -1.2
+ P_std: 1.5
+ gamma_0: 0.8
+ gamma_min: 1.0
+ noise_scale: 1.0
+ step_scale: 1.0
+ coordinate_augmentation: true
+ alignment_reverse_diff: true
+ synchronize_sigmas: true
+ use_inference_model_cache: true
+
+ diffusion_loss_args:
+ add_smooth_lddt_loss: true
+ nucleotide_loss_weight: 5.0
+ ligand_loss_weight: 10.0
+
+ steering_args:
+ fk_steering: False
+ num_particles: 3
+ fk_lambda: 4.0
+ fk_resampling_interval: 3
+ physical_guidance_update: False
+ num_gd_steps: 16
diff --git a/forks/boltz/scripts/train/train.py b/forks/boltz/scripts/train/train.py
new file mode 100644
index 00000000..f83966bd
--- /dev/null
+++ b/forks/boltz/scripts/train/train.py
@@ -0,0 +1,241 @@
+import os
+import random
+import string
+import sys
+from dataclasses import dataclass
+from pathlib import Path
+from typing import Optional
+
+import hydra
+import omegaconf
+import pytorch_lightning as pl
+import torch
+import torch.multiprocessing
+from omegaconf import OmegaConf, listconfig
+from pytorch_lightning import LightningModule
+from pytorch_lightning.callbacks.model_checkpoint import ModelCheckpoint
+from pytorch_lightning.loggers import WandbLogger
+from pytorch_lightning.strategies import DDPStrategy
+from pytorch_lightning.utilities import rank_zero_only
+
+from boltz.data.module.training import BoltzTrainingDataModule, DataConfig
+
+
+@dataclass
+class TrainConfig:
+ """Train configuration.
+
+ Attributes
+ ----------
+ data : DataConfig
+ The data configuration.
+ model : ModelConfig
+ The model configuration.
+ output : str
+ The output directory.
+ trainer : Optional[dict]
+ The trainer configuration.
+ resume : Optional[str]
+ The resume checkpoint.
+ pretrained : Optional[str]
+ The pretrained model.
+ wandb : Optional[dict]
+ The wandb configuration.
+ disable_checkpoint : bool
+ Disable checkpoint.
+ matmul_precision : Optional[str]
+ The matmul precision.
+ find_unused_parameters : Optional[bool]
+ Find unused parameters.
+ save_top_k : Optional[int]
+ Save top k checkpoints.
+ validation_only : bool
+ Run validation only.
+ debug : bool
+ Debug mode.
+ strict_loading : bool
+ Fail on mismatched checkpoint weights.
+ load_confidence_from_trunk: Optional[bool]
+ Load pre-trained confidence weights from trunk.
+
+ """
+
+ data: DataConfig
+ model: LightningModule
+ output: str
+ trainer: Optional[dict] = None
+ resume: Optional[str] = None
+ pretrained: Optional[str] = None
+ wandb: Optional[dict] = None
+ disable_checkpoint: bool = False
+ matmul_precision: Optional[str] = None
+ find_unused_parameters: Optional[bool] = False
+ save_top_k: Optional[int] = 1
+ validation_only: bool = False
+ debug: bool = False
+ strict_loading: bool = True
+ load_confidence_from_trunk: Optional[bool] = False
+
+
+def train(raw_config: str, args: list[str]) -> None: # noqa: C901, PLR0912, PLR0915
+ """Run training.
+
+ Parameters
+ ----------
+ raw_config : str
+ The input yaml configuration.
+ args : list[str]
+ Any command line overrides.
+
+ """
+ # Load the configuration
+ raw_config = omegaconf.OmegaConf.load(raw_config)
+
+ # Apply input arguments
+ args = omegaconf.OmegaConf.from_dotlist(args)
+ raw_config = omegaconf.OmegaConf.merge(raw_config, args)
+
+ # Instantiate the task
+ cfg = hydra.utils.instantiate(raw_config)
+ cfg = TrainConfig(**cfg)
+
+ # Set matmul precision
+ if cfg.matmul_precision is not None:
+ torch.set_float32_matmul_precision(cfg.matmul_precision)
+
+ # Create trainer dict
+ trainer = cfg.trainer
+ if trainer is None:
+ trainer = {}
+
+ # Flip some arguments in debug mode
+ devices = trainer.get("devices", 1)
+
+ wandb = cfg.wandb
+ if cfg.debug:
+ if isinstance(devices, int):
+ devices = 1
+ elif isinstance(devices, (list, listconfig.ListConfig)):
+ devices = [devices[0]]
+ trainer["devices"] = devices
+ cfg.data.num_workers = 0
+ if wandb:
+ wandb = None
+
+ # Create objects
+ data_config = DataConfig(**cfg.data)
+ data_module = BoltzTrainingDataModule(data_config)
+ model_module = cfg.model
+
+ if cfg.pretrained and not cfg.resume:
+ # Load the pretrained weights into the confidence module
+ if cfg.load_confidence_from_trunk:
+ checkpoint = torch.load(cfg.pretrained, map_location="cpu")
+
+ # Modify parameter names in the state_dict
+ new_state_dict = {}
+ for key, value in checkpoint["state_dict"].items():
+ if not key.startswith("structure_module") and not key.startswith(
+ "distogram_module"
+ ):
+ new_key = "confidence_module." + key
+ new_state_dict[new_key] = value
+ new_state_dict.update(checkpoint["state_dict"])
+
+ # Update the checkpoint with the new state_dict
+ checkpoint["state_dict"] = new_state_dict
+
+ # Save the modified checkpoint
+ random_string = "".join(
+ random.choices(string.ascii_lowercase + string.digits, k=10)
+ )
+ file_path = os.path.dirname(cfg.pretrained) + "/" + random_string + ".ckpt"
+ print(
+ f"Saving modified checkpoint to {file_path} created by broadcasting trunk of {cfg.pretrained} to confidence module."
+ )
+ torch.save(checkpoint, file_path)
+ else:
+ file_path = cfg.pretrained
+
+ print(f"Loading model from {file_path}")
+ model_module = type(model_module).load_from_checkpoint(
+ file_path, map_location="cpu", strict=False, **(model_module.hparams)
+ )
+
+ if cfg.load_confidence_from_trunk:
+ os.remove(file_path)
+
+ # Create checkpoint callback
+ callbacks = []
+ dirpath = cfg.output
+ if not cfg.disable_checkpoint:
+ mc = ModelCheckpoint(
+ monitor="val/lddt",
+ save_top_k=cfg.save_top_k,
+ save_last=True,
+ mode="max",
+ every_n_epochs=1,
+ )
+ callbacks = [mc]
+
+ # Create wandb logger
+ loggers = []
+ if wandb:
+ wdb_logger = WandbLogger(
+ name=wandb["name"],
+ group=wandb["name"],
+ save_dir=cfg.output,
+ project=wandb["project"],
+ entity=wandb["entity"],
+ log_model=False,
+ )
+ loggers.append(wdb_logger)
+ # Save the config to wandb
+
+ @rank_zero_only
+ def save_config_to_wandb() -> None:
+ config_out = Path(wdb_logger.experiment.dir) / "run.yaml"
+ with Path.open(config_out, "w") as f:
+ OmegaConf.save(raw_config, f)
+ wdb_logger.experiment.save(str(config_out))
+
+ save_config_to_wandb()
+
+ # Set up trainer
+ strategy = "auto"
+ if (isinstance(devices, int) and devices > 1) or (
+ isinstance(devices, (list, listconfig.ListConfig)) and len(devices) > 1
+ ):
+ strategy = DDPStrategy(find_unused_parameters=cfg.find_unused_parameters)
+
+ trainer = pl.Trainer(
+ default_root_dir=str(dirpath),
+ strategy=strategy,
+ callbacks=callbacks,
+ logger=loggers,
+ enable_checkpointing=not cfg.disable_checkpoint,
+ reload_dataloaders_every_n_epochs=1,
+ **trainer,
+ )
+
+ if not cfg.strict_loading:
+ model_module.strict_loading = False
+
+ if cfg.validation_only:
+ trainer.validate(
+ model_module,
+ datamodule=data_module,
+ ckpt_path=cfg.resume,
+ )
+ else:
+ trainer.fit(
+ model_module,
+ datamodule=data_module,
+ ckpt_path=cfg.resume,
+ )
+
+
+if __name__ == "__main__":
+ arg1 = sys.argv[1]
+ arg2 = sys.argv[2:]
+ train(arg1, arg2)
diff --git a/forks/boltz/src/boltz/__init__.py b/forks/boltz/src/boltz/__init__.py
new file mode 100644
index 00000000..ce79ee0a
--- /dev/null
+++ b/forks/boltz/src/boltz/__init__.py
@@ -0,0 +1,7 @@
+from importlib.metadata import PackageNotFoundError, version
+
+try: # noqa: SIM105
+ __version__ = version("boltz")
+except PackageNotFoundError:
+ # package is not installed
+ pass
diff --git a/forks/boltz/src/boltz/data/__init__.py b/forks/boltz/src/boltz/data/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/data/const.py b/forks/boltz/src/boltz/data/const.py
new file mode 100644
index 00000000..71fc1b62
--- /dev/null
+++ b/forks/boltz/src/boltz/data/const.py
@@ -0,0 +1,1184 @@
+####################################################################################################
+# CHAINS
+####################################################################################################
+
+chain_types = [
+ "PROTEIN",
+ "DNA",
+ "RNA",
+ "NONPOLYMER",
+]
+chain_type_ids = {chain: i for i, chain in enumerate(chain_types)}
+
+out_types = [
+ "dna_protein",
+ "rna_protein",
+ "ligand_protein",
+ "dna_ligand",
+ "rna_ligand",
+ "intra_ligand",
+ "intra_dna",
+ "intra_rna",
+ "intra_protein",
+ "protein_protein",
+ "modified",
+]
+
+out_types_weights_af3 = {
+ "dna_protein": 10.0,
+ "rna_protein": 10.0,
+ "ligand_protein": 10.0,
+ "dna_ligand": 5.0,
+ "rna_ligand": 5.0,
+ "intra_ligand": 20.0,
+ "intra_dna": 4.0,
+ "intra_rna": 16.0,
+ "intra_protein": 20.0,
+ "protein_protein": 20.0,
+ "modified": 0.0,
+}
+
+out_types_weights = {
+ "dna_protein": 5.0,
+ "rna_protein": 5.0,
+ "ligand_protein": 20.0,
+ "dna_ligand": 2.0,
+ "rna_ligand": 2.0,
+ "intra_ligand": 20.0,
+ "intra_dna": 2.0,
+ "intra_rna": 8.0,
+ "intra_protein": 20.0,
+ "protein_protein": 20.0,
+ "modified": 0.0,
+}
+
+
+out_single_types = ["protein", "ligand", "dna", "rna"]
+
+clash_types = [
+ "dna_protein",
+ "rna_protein",
+ "ligand_protein",
+ "protein_protein",
+ "dna_ligand",
+ "rna_ligand",
+ "ligand_ligand",
+ "rna_dna",
+ "dna_dna",
+ "rna_rna",
+]
+
+chain_types_to_clash_type = {
+ frozenset(("PROTEIN", "DNA")): "dna_protein",
+ frozenset(("PROTEIN", "RNA")): "rna_protein",
+ frozenset(("PROTEIN", "NONPOLYMER")): "ligand_protein",
+ frozenset(("PROTEIN",)): "protein_protein",
+ frozenset(("NONPOLYMER", "DNA")): "dna_ligand",
+ frozenset(("NONPOLYMER", "RNA")): "rna_ligand",
+ frozenset(("NONPOLYMER",)): "ligand_ligand",
+ frozenset(("DNA", "RNA")): "rna_dna",
+ frozenset(("DNA",)): "dna_dna",
+ frozenset(("RNA",)): "rna_rna",
+}
+
+chain_type_to_out_single_type = {
+ "PROTEIN": "protein",
+ "DNA": "dna",
+ "RNA": "rna",
+ "NONPOLYMER": "ligand",
+}
+####################################################################################################
+# RESIDUES & TOKENS
+####################################################################################################
+
+
+canonical_tokens = [
+ "ALA",
+ "ARG",
+ "ASN",
+ "ASP",
+ "CYS",
+ "GLN",
+ "GLU",
+ "GLY",
+ "HIS",
+ "ILE",
+ "LEU",
+ "LYS",
+ "MET",
+ "PHE",
+ "PRO",
+ "SER",
+ "THR",
+ "TRP",
+ "TYR",
+ "VAL",
+ "UNK", # unknown protein token
+]
+
+tokens = [
+ "",
+ "-",
+ *canonical_tokens,
+ "A",
+ "G",
+ "C",
+ "U",
+ "N", # unknown rna token
+ "DA",
+ "DG",
+ "DC",
+ "DT",
+ "DN", # unknown dna token
+]
+
+token_ids = {token: i for i, token in enumerate(tokens)}
+num_tokens = len(tokens)
+unk_token = {"PROTEIN": "UNK", "DNA": "DN", "RNA": "N"}
+unk_token_ids = {m: token_ids[t] for m, t in unk_token.items()}
+
+prot_letter_to_token = {
+ "A": "ALA",
+ "R": "ARG",
+ "N": "ASN",
+ "D": "ASP",
+ "C": "CYS",
+ "E": "GLU",
+ "Q": "GLN",
+ "G": "GLY",
+ "H": "HIS",
+ "I": "ILE",
+ "L": "LEU",
+ "K": "LYS",
+ "M": "MET",
+ "F": "PHE",
+ "P": "PRO",
+ "S": "SER",
+ "T": "THR",
+ "W": "TRP",
+ "Y": "TYR",
+ "V": "VAL",
+ "X": "UNK",
+ "J": "UNK",
+ "B": "UNK",
+ "Z": "UNK",
+ "O": "UNK",
+ "U": "UNK",
+ "-": "-",
+}
+
+prot_token_to_letter = {v: k for k, v in prot_letter_to_token.items()}
+prot_token_to_letter["UNK"] = "X"
+
+rna_letter_to_token = {
+ "A": "A",
+ "G": "G",
+ "C": "C",
+ "U": "U",
+ "N": "N",
+}
+rna_token_to_letter = {v: k for k, v in rna_letter_to_token.items()}
+
+dna_letter_to_token = {
+ "A": "DA",
+ "G": "DG",
+ "C": "DC",
+ "T": "DT",
+ "N": "DN",
+}
+dna_token_to_letter = {v: k for k, v in dna_letter_to_token.items()}
+
+####################################################################################################
+# ATOMS
+####################################################################################################
+
+num_elements = 128
+
+chirality_types = [
+ "CHI_UNSPECIFIED",
+ "CHI_TETRAHEDRAL_CW",
+ "CHI_TETRAHEDRAL_CCW",
+ "CHI_SQUAREPLANAR",
+ "CHI_OCTAHEDRAL",
+ "CHI_TRIGONALBIPYRAMIDAL",
+ "CHI_OTHER",
+]
+chirality_type_ids = {chirality: i for i, chirality in enumerate(chirality_types)}
+unk_chirality_type = "CHI_OTHER"
+
+hybridization_map = [
+ "S",
+ "SP",
+ "SP2",
+ "SP2D",
+ "SP3",
+ "SP3D",
+ "SP3D2",
+ "OTHER",
+ "UNSPECIFIED",
+]
+hybridization_type_ids = {hybrid: i for i, hybrid in enumerate(hybridization_map)}
+unk_hybridization_type = "UNSPECIFIED"
+
+# fmt: off
+ref_atoms = {
+ "PAD": [],
+ "UNK": ["N", "CA", "C", "O", "CB"],
+ "-": [],
+ "ALA": ["N", "CA", "C", "O", "CB"],
+ "ARG": ["N", "CA", "C", "O", "CB", "CG", "CD", "NE", "CZ", "NH1", "NH2"],
+ "ASN": ["N", "CA", "C", "O", "CB", "CG", "OD1", "ND2"],
+ "ASP": ["N", "CA", "C", "O", "CB", "CG", "OD1", "OD2"],
+ "CYS": ["N", "CA", "C", "O", "CB", "SG"],
+ "GLN": ["N", "CA", "C", "O", "CB", "CG", "CD", "OE1", "NE2"],
+ "GLU": ["N", "CA", "C", "O", "CB", "CG", "CD", "OE1", "OE2"],
+ "GLY": ["N", "CA", "C", "O"],
+ "HIS": ["N", "CA", "C", "O", "CB", "CG", "ND1", "CD2", "CE1", "NE2"],
+ "ILE": ["N", "CA", "C", "O", "CB", "CG1", "CG2", "CD1"],
+ "LEU": ["N", "CA", "C", "O", "CB", "CG", "CD1", "CD2"],
+ "LYS": ["N", "CA", "C", "O", "CB", "CG", "CD", "CE", "NZ"],
+ "MET": ["N", "CA", "C", "O", "CB", "CG", "SD", "CE"],
+ "PHE": ["N", "CA", "C", "O", "CB", "CG", "CD1", "CD2", "CE1", "CE2", "CZ"],
+ "PRO": ["N", "CA", "C", "O", "CB", "CG", "CD"],
+ "SER": ["N", "CA", "C", "O", "CB", "OG"],
+ "THR": ["N", "CA", "C", "O", "CB", "OG1", "CG2"],
+ "TRP": ["N", "CA", "C", "O", "CB", "CG", "CD1", "CD2", "NE1", "CE2", "CE3", "CZ2", "CZ3", "CH2"], # noqa: E501
+ "TYR": ["N", "CA", "C", "O", "CB", "CG", "CD1", "CD2", "CE1", "CE2", "CZ", "OH"],
+ "VAL": ["N", "CA", "C", "O", "CB", "CG1", "CG2"],
+ "A": ["P", "OP1", "OP2", "O5'", "C5'", "C4'", "O4'", "C3'", "O3'", "C2'", "O2'", "C1'", "N9", "C8", "N7", "C5", "C6", "N6", "N1", "C2", "N3", "C4"], # noqa: E501
+ "G": ["P", "OP1", "OP2", "O5'", "C5'", "C4'", "O4'", "C3'", "O3'", "C2'", "O2'", "C1'", "N9", "C8", "N7", "C5", "C6", "O6", "N1", "C2", "N2", "N3", "C4"], # noqa: E501
+ "C": ["P", "OP1", "OP2", "O5'", "C5'", "C4'", "O4'", "C3'", "O3'", "C2'", "O2'", "C1'", "N1", "C2", "O2", "N3", "C4", "N4", "C5", "C6"], # noqa: E501
+ "U": ["P", "OP1", "OP2", "O5'", "C5'", "C4'", "O4'", "C3'", "O3'", "C2'", "O2'", "C1'", "N1", "C2", "O2", "N3", "C4", "O4", "C5", "C6"], # noqa: E501
+ "N": ["P", "OP1", "OP2", "O5'", "C5'", "C4'", "O4'", "C3'", "O3'", "C2'", "O2'", "C1'"], # noqa: E501
+ "DA": ["P", "OP1", "OP2", "O5'", "C5'", "C4'", "O4'", "C3'", "O3'", "C2'", "C1'", "N9", "C8", "N7", "C5", "C6", "N6", "N1", "C2", "N3", "C4"], # noqa: E501
+ "DG": ["P", "OP1", "OP2", "O5'", "C5'", "C4'", "O4'", "C3'", "O3'", "C2'", "C1'", "N9", "C8", "N7", "C5", "C6", "O6", "N1", "C2", "N2", "N3", "C4"], # noqa: E501
+ "DC": ["P", "OP1", "OP2", "O5'", "C5'", "C4'", "O4'", "C3'", "O3'", "C2'", "C1'", "N1", "C2", "O2", "N3", "C4", "N4", "C5", "C6"], # noqa: E501
+ "DT": ["P", "OP1", "OP2", "O5'", "C5'", "C4'", "O4'", "C3'", "O3'", "C2'", "C1'", "N1", "C2", "O2", "N3", "C4", "O4", "C5", "C7", "C6"], # noqa: E501
+ "DN": ["P", "OP1", "OP2", "O5'", "C5'", "C4'", "O4'", "C3'", "O3'", "C2'", "C1'"]
+}
+
+protein_backbone_atom_names = ["N", "CA", "C", "O"]
+nucleic_backbone_atom_names = ["P", "OP1", "OP2", "O5'", "C5'", "C4'", "O4'", "C3'", "O3'", "C2'", "O2'", "C1'"]
+
+protein_backbone_atom_index = {name: i for i, name in enumerate(protein_backbone_atom_names)}
+nucleic_backbone_atom_index = {name: i for i, name in enumerate(nucleic_backbone_atom_names)}
+
+ref_symmetries = {
+ "PAD": [],
+ "ALA": [],
+ "ARG": [],
+ "ASN": [],
+ "ASP": [[(6, 7), (7, 6)]],
+ "CYS": [],
+ "GLN": [],
+ "GLU": [[(7, 8), (8, 7)]],
+ "GLY": [],
+ "HIS": [],
+ "ILE": [],
+ "LEU": [],
+ "LYS": [],
+ "MET": [],
+ "PHE": [[(6, 7), (7, 6), (8, 9), (9, 8)]],
+ "PRO": [],
+ "SER": [],
+ "THR": [],
+ "TRP": [],
+ "TYR": [[(6, 7), (7, 6), (8, 9), (9, 8)]],
+ "VAL": [],
+ "A": [[(1, 2), (2, 1)]],
+ "G": [[(1, 2), (2, 1)]],
+ "C": [[(1, 2), (2, 1)]],
+ "U": [[(1, 2), (2, 1)]],
+ #"N": [[(1, 2), (2, 1)]],
+ "DA": [[(1, 2), (2, 1)]],
+ "DG": [[(1, 2), (2, 1)]],
+ "DC": [[(1, 2), (2, 1)]],
+ "DT": [[(1, 2), (2, 1)]],
+ #"DN": [[(1, 2), (2, 1)]]
+}
+
+
+res_to_center_atom = {
+ "UNK": "CA",
+ "ALA": "CA",
+ "ARG": "CA",
+ "ASN": "CA",
+ "ASP": "CA",
+ "CYS": "CA",
+ "GLN": "CA",
+ "GLU": "CA",
+ "GLY": "CA",
+ "HIS": "CA",
+ "ILE": "CA",
+ "LEU": "CA",
+ "LYS": "CA",
+ "MET": "CA",
+ "PHE": "CA",
+ "PRO": "CA",
+ "SER": "CA",
+ "THR": "CA",
+ "TRP": "CA",
+ "TYR": "CA",
+ "VAL": "CA",
+ "A": "C1'",
+ "G": "C1'",
+ "C": "C1'",
+ "U": "C1'",
+ "N": "C1'",
+ "DA": "C1'",
+ "DG": "C1'",
+ "DC": "C1'",
+ "DT": "C1'",
+ "DN": "C1'"
+}
+
+res_to_disto_atom = {
+ "UNK": "CB",
+ "ALA": "CB",
+ "ARG": "CB",
+ "ASN": "CB",
+ "ASP": "CB",
+ "CYS": "CB",
+ "GLN": "CB",
+ "GLU": "CB",
+ "GLY": "CA",
+ "HIS": "CB",
+ "ILE": "CB",
+ "LEU": "CB",
+ "LYS": "CB",
+ "MET": "CB",
+ "PHE": "CB",
+ "PRO": "CB",
+ "SER": "CB",
+ "THR": "CB",
+ "TRP": "CB",
+ "TYR": "CB",
+ "VAL": "CB",
+ "A": "C4",
+ "G": "C4",
+ "C": "C2",
+ "U": "C2",
+ "N": "C1'",
+ "DA": "C4",
+ "DG": "C4",
+ "DC": "C2",
+ "DT": "C2",
+ "DN": "C1'"
+}
+
+res_to_center_atom_id = {
+ res: ref_atoms[res].index(atom)
+ for res, atom in res_to_center_atom.items()
+}
+
+res_to_disto_atom_id = {
+ res: ref_atoms[res].index(atom)
+ for res, atom in res_to_disto_atom.items()
+}
+
+# fmt: on
+
+####################################################################################################
+# BONDS
+####################################################################################################
+
+atom_interface_cutoff = 5.0
+interface_cutoff = 15.0
+
+bond_types = [
+ "OTHER",
+ "SINGLE",
+ "DOUBLE",
+ "TRIPLE",
+ "AROMATIC",
+ "COVALENT",
+]
+bond_type_ids = {bond: i for i, bond in enumerate(bond_types)}
+unk_bond_type = "OTHER"
+
+
+####################################################################################################
+# Contacts
+####################################################################################################
+
+
+pocket_contact_info = {
+ "UNSPECIFIED": 0,
+ "UNSELECTED": 1,
+ "POCKET": 2,
+ "BINDER": 3,
+}
+
+contact_conditioning_info = {
+ "UNSPECIFIED": 0,
+ "UNSELECTED": 1,
+ "POCKET>BINDER": 2,
+ "BINDER>POCKET": 3,
+ "CONTACT": 4,
+}
+
+
+####################################################################################################
+# MSA
+####################################################################################################
+
+max_msa_seqs = 16384
+max_paired_seqs = 8192
+
+
+####################################################################################################
+# CHUNKING
+####################################################################################################
+
+chunk_size_threshold = 384
+
+####################################################################################################
+# Method conditioning
+####################################################################################################
+
+# Methods
+method_types_ids = {
+ "MD": 0,
+ "X-RAY DIFFRACTION": 1,
+ "ELECTRON MICROSCOPY": 2,
+ "SOLUTION NMR": 3,
+ "SOLID-STATE NMR": 4,
+ "NEUTRON DIFFRACTION": 4,
+ "ELECTRON CRYSTALLOGRAPHY": 4,
+ "FIBER DIFFRACTION": 4,
+ "POWDER DIFFRACTION": 4,
+ "INFRARED SPECTROSCOPY": 4,
+ "FLUORESCENCE TRANSFER": 4,
+ "EPR": 4,
+ "THEORETICAL MODEL": 4,
+ "SOLUTION SCATTERING": 4,
+ "OTHER": 4,
+ "AFDB": 5,
+ "BOLTZ-1": 6,
+ "FUTURE1": 7, # Placeholder for future supervision sources
+ "FUTURE2": 8,
+ "FUTURE3": 9,
+ "FUTURE4": 10,
+ "FUTURE5": 11,
+}
+method_types_ids = {k.lower(): v for k, v in method_types_ids.items()}
+num_method_types = len(set(method_types_ids.values()))
+
+# Temperature
+temperature_bins = [(265, 280), (280, 295), (295, 310)]
+temperature_bins_ids = {temp: i for i, temp in enumerate(temperature_bins)}
+temperature_bins_ids["other"] = len(temperature_bins)
+num_temp_bins = len(temperature_bins_ids)
+
+
+# pH
+ph_bins = [(0, 6), (6, 8), (8, 14)]
+ph_bins_ids = {ph: i for i, ph in enumerate(ph_bins)}
+ph_bins_ids["other"] = len(ph_bins)
+num_ph_bins = len(ph_bins_ids)
+
+####################################################################################################
+# VDW_RADII
+####################################################################################################
+
+# fmt: off
+vdw_radii = [
+ 1.2, 1.4, 2.2, 1.9, 1.8, 1.7, 1.6, 1.55, 1.5, 1.54,
+ 2.4, 2.2, 2.1, 2.1, 1.95, 1.8, 1.8, 1.88, 2.8, 2.4,
+ 2.3, 2.15, 2.05, 2.05, 2.05, 2.05, 2.0, 2.0, 2.0, 2.1,
+ 2.1, 2.1, 2.05, 1.9, 1.9, 2.02, 2.9, 2.55, 2.4, 2.3,
+ 2.15, 2.1, 2.05, 2.05, 2.0, 2.05, 2.1, 2.2, 2.2, 2.25,
+ 2.2, 2.1, 2.1, 2.16, 3.0, 2.7, 2.5, 2.48, 2.47, 2.45,
+ 2.43, 2.42, 2.4, 2.38, 2.37, 2.35, 2.33, 2.32, 2.3, 2.28,
+ 2.27, 2.25, 2.2, 2.1, 2.05, 2.0, 2.0, 2.05, 2.1, 2.05,
+ 2.2, 2.3, 2.3, 2.0, 2.0, 2.0, 2.0, 2.0, 2.0, 2.4,
+ 2.0, 2.3, 2.0, 2.0, 2.0, 2.0, 2.0, 2.0, 2.0, 2.0,
+ 2.0, 2.0, 2.0, 2.0, 2.0, 2.0, 2.0, 2.0, 2.0, 2.0,
+ 2.0, 2.0, 2.0, 2.0, 2.0, 2.0, 2.0, 2.0
+]
+# fmt: on
+
+####################################################################################################
+# Excluded ligands
+####################################################################################################
+
+ligand_exclusion = {
+ "144",
+ "15P",
+ "1PE",
+ "2F2",
+ "2JC",
+ "3HR",
+ "3SY",
+ "7N5",
+ "7PE",
+ "9JE",
+ "AAE",
+ "ABA",
+ "ACE",
+ "ACN",
+ "ACT",
+ "ACY",
+ "AZI",
+ "BAM",
+ "BCN",
+ "BCT",
+ "BDN",
+ "BEN",
+ "BME",
+ "BO3",
+ "BTB",
+ "BTC",
+ "BU1",
+ "C8E",
+ "CAD",
+ "CAQ",
+ "CBM",
+ "CCN",
+ "CIT",
+ "CL",
+ "CLR",
+ "CM",
+ "CMO",
+ "CO3",
+ "CPT",
+ "CXS",
+ "D10",
+ "DEP",
+ "DIO",
+ "DMS",
+ "DN",
+ "DOD",
+ "DOX",
+ "EDO",
+ "EEE",
+ "EGL",
+ "EOH",
+ "EOX",
+ "EPE",
+ "ETF",
+ "FCY",
+ "FJO",
+ "FLC",
+ "FMT",
+ "FW5",
+ "GOL",
+ "GSH",
+ "GTT",
+ "GYF",
+ "HED",
+ "IHP",
+ "IHS",
+ "IMD",
+ "IOD",
+ "IPA",
+ "IPH",
+ "LDA",
+ "MB3",
+ "MEG",
+ "MES",
+ "MLA",
+ "MLI",
+ "MOH",
+ "MPD",
+ "MRD",
+ "MSE",
+ "MYR",
+ "N",
+ "NA",
+ "NH2",
+ "NH4",
+ "NHE",
+ "NO3",
+ "O4B",
+ "OHE",
+ "OLA",
+ "OLC",
+ "OMB",
+ "OME",
+ "OXA",
+ "P6G",
+ "PE3",
+ "PE4",
+ "PEG",
+ "PEO",
+ "PEP",
+ "PG0",
+ "PG4",
+ "PGE",
+ "PGR",
+ "PLM",
+ "PO4",
+ "POL",
+ "POP",
+ "PVO",
+ "SAR",
+ "SCN",
+ "SEO",
+ "SEP",
+ "SIN",
+ "SO4",
+ "SPD",
+ "SPM",
+ "SR",
+ "STE",
+ "STO",
+ "STU",
+ "TAR",
+ "TBU",
+ "TME",
+ "TPO",
+ "TRS",
+ "UNK",
+ "UNL",
+ "UNX",
+ "UPL",
+ "URE",
+}
+
+
+####################################################################################################
+# TEMPLATES
+####################################################################################################
+
+min_coverage_residues = 10
+min_coverage_fraction = 0.1
+
+
+####################################################################################################
+# Ambiguous atoms
+####################################################################################################
+
+ambiguous_atoms = {
+ "CA": {
+ "*": "C",
+ "OEX": "CA",
+ "OEC": "CA",
+ "543": "CA",
+ "OC6": "CA",
+ "OC1": "CA",
+ "OC7": "CA",
+ "OEY": "CA",
+ "OC4": "CA",
+ "OC3": "CA",
+ "ICA": "CA",
+ "CA": "CA",
+ "OC2": "CA",
+ "OC5": "CA",
+ },
+ "CD": {"*": "C", "CD": "CD", "CD3": "CD", "CD5": "CD", "CD1": "CD"},
+ "BR": "BR",
+ "CL": {
+ "*": "CL",
+ "C8P": "C",
+ "L3T": "C",
+ "TLC": "C",
+ "TZ0": "C",
+ "471": "C",
+ "NLK": "C",
+ "PGM": "C",
+ "PNE": "C",
+ "RCY": "C",
+ "11F": "C",
+ "PII": "C",
+ "C1Q": "C",
+ "4MD": "C",
+ "R5A": "C",
+ "KW2": "C",
+ "I7M": "C",
+ "R48": "C",
+ "FC3": "C",
+ "55V": "C",
+ "KPF": "C",
+ "SPZ": "C",
+ "0TT": "C",
+ "R9A": "C",
+ "5NA": "C",
+ "C55": "C",
+ "NIX": "C",
+ "5PM": "C",
+ "PP8": "C",
+ "544": "C",
+ "812": "C",
+ "NPM": "C",
+ "KU8": "C",
+ "A1AMM": "C",
+ "4S0": "C",
+ "AQC": "C",
+ "2JK": "C",
+ "WJR": "C",
+ "A1AAW": "C",
+ "85E": "C",
+ "MB0": "C",
+ "ZAB": "C",
+ "85K": "C",
+ "GBP": "C",
+ "A1H80": "C",
+ "A1AFR": "C",
+ "L9M": "C",
+ "MYK": "C",
+ "MB9": "C",
+ "38R": "C",
+ "EKB": "C",
+ "NKF": "C",
+ "UMQ": "C",
+ "T4K": "C",
+ "3PT": "C",
+ "A1A7S": "C",
+ "1Q9": "C",
+ "11R": "C",
+ "D2V": "C",
+ "SM8": "C",
+ "IFC": "C",
+ "DB5": "C",
+ "L2T": "C",
+ "GNB": "C",
+ "PP7": "C",
+ "072": "C",
+ "P88": "C",
+ "DRL": "C",
+ "C9W": "C",
+ "NTP": "C",
+ "4HJ": "C",
+ "7NA": "C",
+ "LPC": "C",
+ "T8W": "C",
+ "63R": "C",
+ "570": "C",
+ "R4A": "C",
+ "3BG": "C",
+ "4RB": "C",
+ "GSO": "C",
+ "BQ6": "C",
+ "R4P": "C",
+ "5CP": "C",
+ "TTR": "C",
+ "6UZ": "C",
+ "SPJ": "C",
+ "0SA": "C",
+ "ZL1": "C",
+ "BYG": "C",
+ "F0E": "C",
+ "PC0": "C",
+ "B2Q": "C",
+ "KV6": "C",
+ "NTO": "C",
+ "CLG": "C",
+ "R7U": "C",
+ "SMQ": "C",
+ "GM2": "C",
+ "Z7P": "C",
+ "NXF": "C",
+ "C6Q": "C",
+ "A1G": "C",
+ "433": "C",
+ "L9N": "C",
+ "7OX": "C",
+ "A1H84": "C",
+ "97L": "C",
+ "HDV": "C",
+ "LUO": "C",
+ "R6A": "C",
+ "1PC": "C",
+ "4PT": "C",
+ "SBZ": "C",
+ "EAB": "C",
+ "FL4": "C",
+ "OPS": "C",
+ "C2X": "C",
+ "SLL": "C",
+ "BFC": "C",
+ "GIP": "C",
+ "7CP": "C",
+ "CLH": "C",
+ "34E": "C",
+ "5NE": "C",
+ "PBF": "C",
+ "ABD": "C",
+ "ABC": "C",
+ "LPF": "C",
+ "TIZ": "C",
+ "4HH": "C",
+ "AFC": "C",
+ "WQH": "C",
+ "9JL": "C",
+ "CS3": "C",
+ "NL0": "C",
+ "KPY": "C",
+ "DNA": "C",
+ "B3C": "C",
+ "TKL": "C",
+ "KVS": "C",
+ "HO6": "C",
+ "NLH": "C",
+ "1PB": "C",
+ "CYF": "C",
+ "G4M": "C",
+ "R5B": "C",
+ "N4S": "C",
+ "N11": "C",
+ "C8F": "C",
+ "PIJ": "C",
+ "WIN": "C",
+ "NT1": "C",
+ "WJW": "C",
+ "HF7": "C",
+ "TY1": "C",
+ "VM1": "C",
+ },
+ "OS": {"*": "O", "DWC": "OS", "OHX": "OS", "OS": "OS", "8WV": "OS", "OS4": "OS"},
+ "PB": {"*": "P", "ZN9": "PB", "ZN7": "PB", "PBM": "PB", "PB": "PB", "CSB": "PB"},
+ "CE": {"*": "C", "CE": "CE"},
+ "FE": {"*": "FE", "TFR": "F", "PF5": "F", "IFC": "F", "F5C": "F"},
+ "NA": {"*": "N", "CGO": "NA", "R2K": "NA", "LVQ": "NA", "NA": "NA"},
+ "ND": {"*": "N", "ND": "ND"},
+ "CF": {"*": "C", "CF": "CF"},
+ "RU": "RU",
+ "BRAF": "BR",
+ "EU": "EU",
+ "CLAA": "CL",
+ "CLBQ": "CL",
+ "CM": {"*": "C", "ZCM": "CM"},
+ "SN": {"*": "SN", "TAP": "S", "SND": "S", "TAD": "S", "XPT": "S"},
+ "AG": "AG",
+ "CLN": "CL",
+ "CLM": "CL",
+ "CLA": {"*": "CL", "PII": "C", "TDL": "C", "D0J": "C", "GM2": "C", "PIJ": "C"},
+ "CLB": {
+ "*": "CL",
+ "TD5": "C",
+ "PII": "C",
+ "TDL": "C",
+ "GM2": "C",
+ "TD7": "C",
+ "TD6": "C",
+ "PIJ": "C",
+ },
+ "CR": {
+ "*": "C",
+ "BW9": "CR",
+ "CQ4": "CR",
+ "AC9": "CR",
+ "TIL": "CR",
+ "J7U": "CR",
+ "CR": "CR",
+ },
+ "CLAY": "CL",
+ "CLBC": "CL",
+ "PD": {
+ "*": "P",
+ "F6Q": "PD",
+ "SVP": "PD",
+ "SXC": "PD",
+ "U5U": "PD",
+ "PD": "PD",
+ "PLL": "PD",
+ },
+ "CO": {
+ "*": "C",
+ "J1S": "CO",
+ "OCN": "CO",
+ "OL3": "CO",
+ "OL4": "CO",
+ "B12": "CO",
+ "XCO": "CO",
+ "UFU": "CO",
+ "CON": "CO",
+ "OL5": "CO",
+ "B13": "CO",
+ "7KI": "CO",
+ "PL1": "CO",
+ "OCO": "CO",
+ "J1R": "CO",
+ "COH": "CO",
+ "SIR": "CO",
+ "6KI": "CO",
+ "NCO": "CO",
+ "9CO": "CO",
+ "PC3": "CO",
+ "BWU": "CO",
+ "B1Z": "CO",
+ "J83": "CO",
+ "CO": "CO",
+ "COY": "CO",
+ "CNC": "CO",
+ "3CO": "CO",
+ "OCL": "CO",
+ "R5Q": "CO",
+ "X5Z": "CO",
+ "CBY": "CO",
+ "OLS": "CO",
+ "F0X": "CO",
+ "I2A": "CO",
+ "OCM": "CO",
+ },
+ "CU": {
+ "*": "C",
+ "8ZR": "CU",
+ "K7E": "CU",
+ "CU3": "CU",
+ "SI9": "CU",
+ "35N": "CU",
+ "C2O": "CU",
+ "SI7": "CU",
+ "B15": "CU",
+ "SI0": "CU",
+ "CUP": "CU",
+ "SQ1": "CU",
+ "CUK": "CU",
+ "CUL": "CU",
+ "SI8": "CU",
+ "IC4": "CU",
+ "CUM": "CU",
+ "MM2": "CU",
+ "B30": "CU",
+ "S32": "CU",
+ "V79": "CU",
+ "IMF": "CU",
+ "CUN": "CU",
+ "MM1": "CU",
+ "MP1": "CU",
+ "IME": "CU",
+ "B17": "CU",
+ "C2C": "CU",
+ "1CU": "CU",
+ "CU6": "CU",
+ "C1O": "CU",
+ "CU1": "CU",
+ "B22": "CU",
+ "CUS": "CU",
+ "RUQ": "CU",
+ "CUF": "CU",
+ "CUA": "CU",
+ "CU": "CU",
+ "CUO": "CU",
+ "0TE": "CU",
+ "SI4": "CU",
+ },
+ "CS": {"*": "C", "CS": "CS"},
+ "CLQ": "CL",
+ "CLR": "CL",
+ "CLU": "CL",
+ "TE": "TE",
+ "NI": {
+ "*": "N",
+ "USN": "NI",
+ "NFO": "NI",
+ "NI2": "NI",
+ "NFS": "NI",
+ "NFR": "NI",
+ "82N": "NI",
+ "R5N": "NI",
+ "NFU": "NI",
+ "A1ICD": "NI",
+ "NI3": "NI",
+ "M43": "NI",
+ "MM5": "NI",
+ "BF8": "NI",
+ "TCN": "NI",
+ "NIK": "NI",
+ "CUV": "NI",
+ "MM6": "NI",
+ "J52": "NI",
+ "NI": "NI",
+ "SNF": "NI",
+ "XCC": "NI",
+ "F0L": "NI",
+ "UWE": "NI",
+ "NFC": "NI",
+ "3NI": "NI",
+ "HNI": "NI",
+ "F43": "NI",
+ "RQM": "NI",
+ "NFE": "NI",
+ "NFB": "NI",
+ "B51": "NI",
+ "NI1": "NI",
+ "WCC": "NI",
+ "NUF": "NI",
+ },
+ "SB": {"*": "S", "UJI": "SB", "SB": "SB", "118": "SB", "SBO": "SB", "3CG": "SB"},
+ "MO": "MO",
+ "SEG": "SE",
+ "CLL": "CL",
+ "CLAH": "CL",
+ "CLC": {
+ "*": "CL",
+ "TD5": "C",
+ "PII": "C",
+ "TDL": "C",
+ "GM2": "C",
+ "TD7": "C",
+ "TD6": "C",
+ "PIJ": "C",
+ },
+ "CLD": {"*": "CL", "PII": "C", "GM2": "C", "PIJ": "C"},
+ "CLAD": "CL",
+ "CLAE": "CL",
+ "LA": "LA",
+ "RH": "RH",
+ "BRAC": "BR",
+ "BRAD": "BR",
+ "CLBN": "CL",
+ "CLAC": "CL",
+ "BRAB": "BR",
+ "BRAE": "BR",
+ "MG": "MG",
+ "IR": "IR",
+ "SE": {
+ "*": "SE",
+ "HII": "S",
+ "NT2": "S",
+ "R2P": "S",
+ "S2P": "S",
+ "0IU": "S",
+ "QMB": "S",
+ "81S": "S",
+ "0QB": "S",
+ "UB4": "S",
+ "OHS": "S",
+ "Q78": "S",
+ "0Y2": "S",
+ "B3M": "S",
+ "NT1": "S",
+ "81R": "S",
+ },
+ "BRAG": "BR",
+ "CLF": {"*": "CL", "PII": "C", "GM2": "C", "PIJ": "C"},
+ "CLE": {"*": "CL", "PII": "C", "GM2": "C", "PIJ": "C"},
+ "BRAX": "BR",
+ "CLK": "CL",
+ "ZN": "ZN",
+ "AS": "AS",
+ "AU": "AU",
+ "PT": "PT",
+ "CLAS": "CL",
+ "MN": "MN",
+ "CLBE": "CL",
+ "CLBF": "CL",
+ "CLAF": "CL",
+ "NA'": {"*": "N", "CGO": "NA"},
+ "BRAH": "BR",
+ "BRAI": "BR",
+ "BRA": "BR",
+ "BRB": "BR",
+ "BRAV": "BR",
+ "HG": {
+ "*": "HG",
+ "BBA": "H",
+ "MID": "H",
+ "APM": "H",
+ "4QQ": "H",
+ "0ZG": "H",
+ "APH": "H",
+ },
+ "AR": "AR",
+ "D": "H",
+ "CLAN": "CL",
+ "SI": "SI",
+ "CLS": "CL",
+ "ZR": "ZR",
+ "CLAR": {"*": "CL", "ZM4": "C"},
+ "HO": "HO",
+ "CLI": {"*": "CL", "GM2": "C"},
+ "CLH": {"*": "CL", "GM2": "C"},
+ "CLAP": "CL",
+ "CLBL": "CL",
+ "CLBM": "CL",
+ "PR": {"*": "PR", "UF0": "P", "252": "P"},
+ "IN": "IN",
+ "CLJ": "CL",
+ "BRU": "BR",
+ "SC": {"*": "S", "SFL": "SC"},
+ "CLG": {"*": "CL", "GM2": "C"},
+ "BRAT": "BR",
+ "BRAR": "BR",
+ "CLAG": "CL",
+ "CLAB": "CL",
+ "CLV": "CL",
+ "TI": "TI",
+ "CLAX": "CL",
+ "CLAJ": "CL",
+ "CL'": {"*": "CL", "BNR": "C", "25A": "C", "BDA": "C"},
+ "CLAW": "CL",
+ "BRF": "BR",
+ "BRE": "BR",
+ "RE": "RE",
+ "GD": "GD",
+ "SM": {"*": "S", "SM": "SM"},
+ "CLBH": "CL",
+ "CLBI": "CL",
+ "CLAI": "CL",
+ "CLY": "CL",
+ "CLZ": "CL",
+ "AC": "AC",
+ "BR'": "BR",
+ "CLT": "CL",
+ "CLO": "CL",
+ "CLP": "CL",
+ "LU": "LU",
+ "BA": {"*": "B", "BA": "BA"},
+ "CLAU": "CL",
+ "RB": "RB",
+ "LI": "LI",
+ "MOM": "MO",
+ "BRAQ": "BR",
+ "SR": {"*": "S", "SR": "SR", "OER": "SR"},
+ "CLAT": "CL",
+ "BRAL": "BR",
+ "SEB": "SE",
+ "CLW": "CL",
+ "CLX": "CL",
+ "BE": "BE",
+ "BRG": "BR",
+ "SEA": "SE",
+ "BRAW": "BR",
+ "BRBB": "BR",
+ "ER": "ER",
+ "TH": "TH",
+ "BRR": "BR",
+ "CLBV": "CL",
+ "AL": "AL",
+ "CLAV": "CL",
+ "BRH": "BR",
+ "CLAQ": "CL",
+ "GA": "GA",
+ "X": "*",
+ "TL": "TL",
+ "CLBB": "CL",
+ "TB": "TB",
+ "CLAK": "CL",
+ "XE": {"*": "*", "XE": "XE"},
+ "SEL": "SE",
+ "PU": {"*": "P", "4PU": "PU"},
+ "CLAZ": "CL",
+ "SE'": "SE",
+ "CLBA": "CL",
+ "SEN": "SE",
+ "SNN": "SN",
+ "MOB": "MO",
+ "YB": "YB",
+ "BRC": "BR",
+ "BRD": "BR",
+ "CLAM": "CL",
+ "DA": "H",
+ "DB": "H",
+ "DC": "H",
+ "DXT": "H",
+ "DXU": "H",
+ "DXX": "H",
+ "DXY": "H",
+ "DXZ": "H",
+ "DY": "DY",
+ "TA": "TA",
+ "XD": "*",
+ "SED": "SE",
+ "CLAL": "CL",
+ "BRAJ": "BR",
+ "AM": "AM",
+ "CLAO": "CL",
+ "BI": "BI",
+ "KR": "KR",
+ "BRBJ": "BR",
+ "UNK": "*",
+}
diff --git a/forks/boltz/src/boltz/data/crop/__init__.py b/forks/boltz/src/boltz/data/crop/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/data/crop/affinity.py b/forks/boltz/src/boltz/data/crop/affinity.py
new file mode 100644
index 00000000..32a9a4d3
--- /dev/null
+++ b/forks/boltz/src/boltz/data/crop/affinity.py
@@ -0,0 +1,164 @@
+from dataclasses import replace
+from typing import Optional
+
+import numpy as np
+
+from boltz.data import const
+from boltz.data.crop.cropper import Cropper
+from boltz.data.types import Tokenized
+
+
+class AffinityCropper(Cropper):
+ """Interpolate between contiguous and spatial crops."""
+
+ def __init__(
+ self,
+ neighborhood_size: int = 10,
+ max_tokens_protein: int = 200,
+ ) -> None:
+ """Initialize the cropper.
+
+ Parameters
+ ----------
+ neighborhood_size : int
+ Modulates the type of cropping to be performed.
+ Smaller neighborhoods result in more spatial
+ cropping. Larger neighborhoods result in more
+ continuous cropping.
+
+ """
+ self.neighborhood_size = neighborhood_size
+ self.max_tokens_protein = max_tokens_protein
+
+ def crop(
+ self,
+ data: Tokenized,
+ max_tokens: int,
+ max_atoms: Optional[int] = None,
+ ) -> Tokenized:
+ """Crop the data to a maximum number of tokens.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The tokenized data.
+ max_tokens : int
+ The maximum number of tokens to crop.
+ random : np.random.RandomState
+ The random state for reproducibility.
+ max_atoms : Optional[int]
+ The maximum number of atoms to consider.
+
+ Returns
+ -------
+ Tokenized
+ The cropped data.
+
+ """
+ # Get token data
+ token_data = data.tokens
+ token_bonds = data.bonds
+
+ # Filter to resolved tokens
+ valid_tokens = token_data[token_data["resolved_mask"]]
+
+ # Check if we have any valid tokens
+ if not valid_tokens.size:
+ msg = "No valid tokens in structure"
+ raise ValueError(msg)
+
+ # compute minimum distance to ligand
+ ligand_coords = valid_tokens[valid_tokens["affinity_mask"]]["center_coords"]
+ dists = np.min(
+ np.sum(
+ (valid_tokens["center_coords"][:, None] - ligand_coords[None]) ** 2,
+ axis=-1,
+ )
+ ** 0.5,
+ axis=1,
+ )
+
+ indices = np.argsort(dists)
+
+ # Select cropped indices
+ cropped: set[int] = set()
+ total_atoms = 0
+
+ # protein tokens
+ cropped_protein: set[int] = set()
+ ligand_ids = set(
+ valid_tokens[
+ valid_tokens["mol_type"] == const.chain_type_ids["NONPOLYMER"]
+ ]["token_idx"]
+ )
+
+ for idx in indices:
+ # Get the token
+ token = valid_tokens[idx]
+
+ # Get all tokens from this chain
+ chain_tokens = token_data[token_data["asym_id"] == token["asym_id"]]
+
+ # Pick the whole chain if possible, otherwise select
+ # a contiguous subset centered at the query token
+ if len(chain_tokens) <= self.neighborhood_size:
+ new_tokens = chain_tokens
+ else:
+ # First limit to the maximum set of tokens, with the
+ # neighborhood on both sides to handle edges. This
+ # is mostly for efficiency with the while loop below.
+ min_idx = token["res_idx"] - self.neighborhood_size
+ max_idx = token["res_idx"] + self.neighborhood_size
+
+ max_token_set = chain_tokens
+ max_token_set = max_token_set[max_token_set["res_idx"] >= min_idx]
+ max_token_set = max_token_set[max_token_set["res_idx"] <= max_idx]
+
+ # Start by adding just the query token
+ new_tokens = max_token_set[max_token_set["res_idx"] == token["res_idx"]]
+
+ # Expand the neighborhood until we have enough tokens, one
+ # by one to handle some edge cases with non-standard chains.
+ # We switch to the res_idx instead of the token_idx to always
+ # include all tokens from modified residues or from ligands.
+ min_idx = max_idx = token["res_idx"]
+ while new_tokens.size < self.neighborhood_size:
+ min_idx = min_idx - 1
+ max_idx = max_idx + 1
+ new_tokens = max_token_set
+ new_tokens = new_tokens[new_tokens["res_idx"] >= min_idx]
+ new_tokens = new_tokens[new_tokens["res_idx"] <= max_idx]
+
+ # Compute new tokens and new atoms
+ new_indices = set(new_tokens["token_idx"]) - cropped
+ new_tokens = token_data[list(new_indices)]
+ new_atoms = np.sum(new_tokens["atom_num"])
+
+ # Stop if we exceed the max number of tokens or atoms
+ if (
+ (len(new_indices) > (max_tokens - len(cropped)))
+ or ((max_atoms is not None) and ((total_atoms + new_atoms) > max_atoms))
+ or (
+ len(cropped_protein | new_indices - ligand_ids)
+ > self.max_tokens_protein
+ )
+ ):
+ break
+
+ # Add new indices
+ cropped.update(new_indices)
+ total_atoms += new_atoms
+
+ # Add protein indices
+ cropped_protein.update(new_indices - ligand_ids)
+
+ # Get the cropped tokens sorted by index
+ token_data = token_data[sorted(cropped)]
+
+ # Only keep bonds within the cropped tokens
+ indices = token_data["token_idx"]
+ token_bonds = token_bonds[np.isin(token_bonds["token_1"], indices)]
+ token_bonds = token_bonds[np.isin(token_bonds["token_2"], indices)]
+
+ # Return the cropped tokens
+ return replace(data, tokens=token_data, bonds=token_bonds)
diff --git a/forks/boltz/src/boltz/data/crop/boltz.py b/forks/boltz/src/boltz/data/crop/boltz.py
new file mode 100644
index 00000000..2e4b31cb
--- /dev/null
+++ b/forks/boltz/src/boltz/data/crop/boltz.py
@@ -0,0 +1,296 @@
+from dataclasses import replace
+from typing import Optional
+
+import numpy as np
+from scipy.spatial.distance import cdist
+
+from boltz.data import const
+from boltz.data.crop.cropper import Cropper
+from boltz.data.types import Tokenized
+
+
+def pick_random_token(
+ tokens: np.ndarray,
+ random: np.random.RandomState,
+) -> np.ndarray:
+ """Pick a random token from the data.
+
+ Parameters
+ ----------
+ tokens : np.ndarray
+ The token data.
+ random : np.ndarray
+ The random state for reproducibility.
+
+ Returns
+ -------
+ np.ndarray
+ The selected token.
+
+ """
+ return tokens[random.randint(len(tokens))]
+
+
+def pick_chain_token(
+ tokens: np.ndarray,
+ chain_id: int,
+ random: np.random.RandomState,
+) -> np.ndarray:
+ """Pick a random token from a chain.
+
+ Parameters
+ ----------
+ tokens : np.ndarray
+ The token data.
+ chain_id : int
+ The chain ID.
+ random : np.ndarray
+ The random state for reproducibility.
+
+ Returns
+ -------
+ np.ndarray
+ The selected token.
+
+ """
+ # Filter to chain
+ chain_tokens = tokens[tokens["asym_id"] == chain_id]
+
+ # Pick from chain, fallback to all tokens
+ if chain_tokens.size:
+ query = pick_random_token(chain_tokens, random)
+ else:
+ query = pick_random_token(tokens, random)
+
+ return query
+
+
+def pick_interface_token(
+ tokens: np.ndarray,
+ interface: np.ndarray,
+ random: np.random.RandomState,
+) -> np.ndarray:
+ """Pick a random token from an interface.
+
+ Parameters
+ ----------
+ tokens : np.ndarray
+ The token data.
+ interface : int
+ The interface ID.
+ random : np.ndarray
+ The random state for reproducibility.
+
+ Returns
+ -------
+ np.ndarray
+ The selected token.
+
+ """
+ # Sample random interface
+ chain_1 = int(interface["chain_1"])
+ chain_2 = int(interface["chain_2"])
+
+ tokens_1 = tokens[tokens["asym_id"] == chain_1]
+ tokens_2 = tokens[tokens["asym_id"] == chain_2]
+
+ # If no interface, pick from the chains
+ if tokens_1.size and (not tokens_2.size):
+ query = pick_random_token(tokens_1, random)
+ elif tokens_2.size and (not tokens_1.size):
+ query = pick_random_token(tokens_2, random)
+ elif (not tokens_1.size) and (not tokens_2.size):
+ query = pick_random_token(tokens, random)
+ else:
+ # If we have tokens, compute distances
+ tokens_1_coords = tokens_1["center_coords"]
+ tokens_2_coords = tokens_2["center_coords"]
+
+ dists = cdist(tokens_1_coords, tokens_2_coords)
+ cuttoff = dists < const.interface_cutoff
+
+ # In rare cases, the interface cuttoff is slightly
+ # too small, then we slightly expand it if it happens
+ if not np.any(cuttoff):
+ cuttoff = dists < (const.interface_cutoff + 5.0)
+
+ tokens_1 = tokens_1[np.any(cuttoff, axis=1)]
+ tokens_2 = tokens_2[np.any(cuttoff, axis=0)]
+
+ # Select random token
+ candidates = np.concatenate([tokens_1, tokens_2])
+ query = pick_random_token(candidates, random)
+
+ return query
+
+
+class BoltzCropper(Cropper):
+ """Interpolate between contiguous and spatial crops."""
+
+ def __init__(self, min_neighborhood: int = 0, max_neighborhood: int = 40) -> None:
+ """Initialize the cropper.
+
+ Modulates the type of cropping to be performed.
+ Smaller neighborhoods result in more spatial
+ cropping. Larger neighborhoods result in more
+ continuous cropping. A mix can be achieved by
+ providing a range over which to sample.
+
+ Parameters
+ ----------
+ min_neighborhood : int
+ The minimum neighborhood size, by default 0.
+ max_neighborhood : int
+ The maximum neighborhood size, by default 40.
+
+ """
+ sizes = list(range(min_neighborhood, max_neighborhood + 1, 2))
+ self.neighborhood_sizes = sizes
+
+ def crop( # noqa: PLR0915
+ self,
+ data: Tokenized,
+ max_tokens: int,
+ random: np.random.RandomState,
+ max_atoms: Optional[int] = None,
+ chain_id: Optional[int] = None,
+ interface_id: Optional[int] = None,
+ ) -> Tokenized:
+ """Crop the data to a maximum number of tokens.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The tokenized data.
+ max_tokens : int
+ The maximum number of tokens to crop.
+ random : np.random.RandomState
+ The random state for reproducibility.
+ max_atoms : int, optional
+ The maximum number of atoms to consider.
+ chain_id : int, optional
+ The chain ID to crop.
+ interface_id : int, optional
+ The interface ID to crop.
+
+ Returns
+ -------
+ Tokenized
+ The cropped data.
+
+ """
+ # Check inputs
+ if chain_id is not None and interface_id is not None:
+ msg = "Only one of chain_id or interface_id can be provided."
+ raise ValueError(msg)
+
+ # Randomly select a neighborhood size
+ neighborhood_size = random.choice(self.neighborhood_sizes)
+
+ # Get token data
+ token_data = data.tokens
+ token_bonds = data.bonds
+ mask = data.structure.mask
+ chains = data.structure.chains
+ interfaces = data.structure.interfaces
+
+ # Filter to valid chains
+ valid_chains = chains[mask]
+
+ # Filter to valid interfaces
+ valid_interfaces = interfaces
+ valid_interfaces = valid_interfaces[mask[valid_interfaces["chain_1"]]]
+ valid_interfaces = valid_interfaces[mask[valid_interfaces["chain_2"]]]
+
+ # Filter to resolved tokens
+ valid_tokens = token_data[token_data["resolved_mask"]]
+
+ # Check if we have any valid tokens
+ if not valid_tokens.size:
+ msg = "No valid tokens in structure"
+ raise ValueError(msg)
+
+ # Pick a random token, chain, or interface
+ if chain_id is not None:
+ query = pick_chain_token(valid_tokens, chain_id, random)
+ elif interface_id is not None:
+ interface = interfaces[interface_id]
+ query = pick_interface_token(valid_tokens, interface, random)
+ elif valid_interfaces.size:
+ idx = random.randint(len(valid_interfaces))
+ interface = valid_interfaces[idx]
+ query = pick_interface_token(valid_tokens, interface, random)
+ else:
+ idx = random.randint(len(valid_chains))
+ chain_id = valid_chains[idx]["asym_id"]
+ query = pick_chain_token(valid_tokens, chain_id, random)
+
+ # Sort all tokens by distance to query_coords
+ dists = valid_tokens["center_coords"] - query["center_coords"]
+ indices = np.argsort(np.linalg.norm(dists, axis=1))
+
+ # Select cropped indices
+ cropped: set[int] = set()
+ total_atoms = 0
+ for idx in indices:
+ # Get the token
+ token = valid_tokens[idx]
+
+ # Get all tokens from this chain
+ chain_tokens = token_data[token_data["asym_id"] == token["asym_id"]]
+
+ # Pick the whole chain if possible, otherwise select
+ # a contiguous subset centered at the query token
+ if len(chain_tokens) <= neighborhood_size:
+ new_tokens = chain_tokens
+ else:
+ # First limit to the maximum set of tokens, with the
+ # neighborhood on both sides to handle edges. This
+ # is mostly for efficiency with the while loop below.
+ min_idx = token["res_idx"] - neighborhood_size
+ max_idx = token["res_idx"] + neighborhood_size
+
+ max_token_set = chain_tokens
+ max_token_set = max_token_set[max_token_set["res_idx"] >= min_idx]
+ max_token_set = max_token_set[max_token_set["res_idx"] <= max_idx]
+
+ # Start by adding just the query token
+ new_tokens = max_token_set[max_token_set["res_idx"] == token["res_idx"]]
+
+ # Expand the neighborhood until we have enough tokens, one
+ # by one to handle some edge cases with non-standard chains.
+ # We switch to the res_idx instead of the token_idx to always
+ # include all tokens from modified residues or from ligands.
+ min_idx = max_idx = token["res_idx"]
+ while new_tokens.size < neighborhood_size:
+ min_idx = min_idx - 1
+ max_idx = max_idx + 1
+ new_tokens = max_token_set
+ new_tokens = new_tokens[new_tokens["res_idx"] >= min_idx]
+ new_tokens = new_tokens[new_tokens["res_idx"] <= max_idx]
+
+ # Compute new tokens and new atoms
+ new_indices = set(new_tokens["token_idx"]) - cropped
+ new_tokens = token_data[list(new_indices)]
+ new_atoms = np.sum(new_tokens["atom_num"])
+
+ # Stop if we exceed the max number of tokens or atoms
+ if (len(new_indices) > (max_tokens - len(cropped))) or (
+ (max_atoms is not None) and ((total_atoms + new_atoms) > max_atoms)
+ ):
+ break
+
+ # Add new indices
+ cropped.update(new_indices)
+ total_atoms += new_atoms
+
+ # Get the cropped tokens sorted by index
+ token_data = token_data[sorted(cropped)]
+
+ # Only keep bonds within the cropped tokens
+ indices = token_data["token_idx"]
+ token_bonds = token_bonds[np.isin(token_bonds["token_1"], indices)]
+ token_bonds = token_bonds[np.isin(token_bonds["token_2"], indices)]
+
+ # Return the cropped tokens
+ return replace(data, tokens=token_data, bonds=token_bonds)
diff --git a/forks/boltz/src/boltz/data/crop/cropper.py b/forks/boltz/src/boltz/data/crop/cropper.py
new file mode 100644
index 00000000..4eb1dbf3
--- /dev/null
+++ b/forks/boltz/src/boltz/data/crop/cropper.py
@@ -0,0 +1,45 @@
+from abc import ABC, abstractmethod
+from typing import Optional
+
+import numpy as np
+
+from boltz.data.types import Tokenized
+
+
+class Cropper(ABC):
+ """Abstract base class for cropper."""
+
+ @abstractmethod
+ def crop(
+ self,
+ data: Tokenized,
+ max_tokens: int,
+ random: np.random.RandomState,
+ max_atoms: Optional[int] = None,
+ chain_id: Optional[int] = None,
+ interface_id: Optional[int] = None,
+ ) -> Tokenized:
+ """Crop the data to a maximum number of tokens.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The tokenized data.
+ max_tokens : int
+ The maximum number of tokens to crop.
+ random : np.random.RandomState
+ The random state for reproducibility.
+ max_atoms : Optional[int]
+ The maximum number of atoms to consider.
+ chain_id : Optional[int]
+ The chain ID to crop.
+ interface_id : Optional[int]
+ The interface ID to crop.
+
+ Returns
+ -------
+ Tokenized
+ The cropped data.
+
+ """
+ raise NotImplementedError
diff --git a/forks/boltz/src/boltz/data/feature/__init__.py b/forks/boltz/src/boltz/data/feature/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/data/feature/featurizer.py b/forks/boltz/src/boltz/data/feature/featurizer.py
new file mode 100644
index 00000000..4f314338
--- /dev/null
+++ b/forks/boltz/src/boltz/data/feature/featurizer.py
@@ -0,0 +1,1224 @@
+import math
+import random
+from typing import Optional
+from collections import deque
+import numba
+import numpy as np
+import numpy.typing as npt
+import torch
+from numba import types
+from torch import Tensor, from_numpy
+from torch.nn.functional import one_hot
+
+from boltz.data import const
+from boltz.data.feature.symmetry import (
+ get_amino_acids_symmetries,
+ get_chain_symmetries,
+ get_ligand_symmetries,
+)
+from boltz.data.pad import pad_dim
+from boltz.data.types import (
+ MSA,
+ MSADeletion,
+ MSAResidue,
+ MSASequence,
+ Tokenized,
+)
+from boltz.model.modules.utils import center_random_augmentation
+
+####################################################################################################
+# HELPERS
+####################################################################################################
+
+
+def compute_frames_nonpolymer(
+ data: Tokenized,
+ coords,
+ resolved_mask,
+ atom_to_token,
+ frame_data: list,
+ resolved_frame_data: list,
+) -> tuple[list, list]:
+ """Get the frames for non-polymer tokens.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The tokenized data.
+ frame_data : list
+ The frame data.
+ resolved_frame_data : list
+ The resolved frame data.
+
+ Returns
+ -------
+ tuple[list, list]
+ The frame data and resolved frame data.
+
+ """
+ frame_data = np.array(frame_data)
+ resolved_frame_data = np.array(resolved_frame_data)
+ asym_id_token = data.tokens["asym_id"]
+ asym_id_atom = data.tokens["asym_id"][atom_to_token]
+ token_idx = 0
+ atom_idx = 0
+ for id in np.unique(data.tokens["asym_id"]):
+ mask_chain_token = asym_id_token == id
+ mask_chain_atom = asym_id_atom == id
+ num_tokens = mask_chain_token.sum()
+ num_atoms = mask_chain_atom.sum()
+ if (
+ data.tokens[token_idx]["mol_type"] != const.chain_type_ids["NONPOLYMER"]
+ or num_atoms < 3
+ ):
+ token_idx += num_tokens
+ atom_idx += num_atoms
+ continue
+ dist_mat = (
+ (
+ coords.reshape(-1, 3)[mask_chain_atom][:, None, :]
+ - coords.reshape(-1, 3)[mask_chain_atom][None, :, :]
+ )
+ ** 2
+ ).sum(-1) ** 0.5
+ resolved_pair = 1 - (
+ resolved_mask[mask_chain_atom][None, :]
+ * resolved_mask[mask_chain_atom][:, None]
+ ).astype(np.float32)
+ resolved_pair[resolved_pair == 1] = math.inf
+ indices = np.argsort(dist_mat + resolved_pair, axis=1)
+ frames = (
+ np.concatenate(
+ [
+ indices[:, 1:2],
+ indices[:, 0:1],
+ indices[:, 2:3],
+ ],
+ axis=1,
+ )
+ + atom_idx
+ )
+ frame_data[token_idx : token_idx + num_atoms, :] = frames
+ resolved_frame_data[token_idx : token_idx + num_atoms] = resolved_mask[
+ frames
+ ].all(axis=1)
+ token_idx += num_tokens
+ atom_idx += num_atoms
+ frames_expanded = coords.reshape(-1, 3)[frame_data]
+
+ mask_collinear = compute_collinear_mask(
+ frames_expanded[:, 1] - frames_expanded[:, 0],
+ frames_expanded[:, 1] - frames_expanded[:, 2],
+ )
+ return frame_data, resolved_frame_data & mask_collinear
+
+
+def compute_collinear_mask(v1, v2):
+ norm1 = np.linalg.norm(v1, axis=1, keepdims=True)
+ norm2 = np.linalg.norm(v2, axis=1, keepdims=True)
+ v1 = v1 / (norm1 + 1e-6)
+ v2 = v2 / (norm2 + 1e-6)
+ mask_angle = np.abs(np.sum(v1 * v2, axis=1)) < 0.9063
+ mask_overlap1 = norm1.reshape(-1) > 1e-2
+ mask_overlap2 = norm2.reshape(-1) > 1e-2
+ return mask_angle & mask_overlap1 & mask_overlap2
+
+
+def dummy_msa(residues: np.ndarray) -> MSA:
+ """Create a dummy MSA for a chain.
+
+ Parameters
+ ----------
+ residues : np.ndarray
+ The residues for the chain.
+
+ Returns
+ -------
+ MSA
+ The dummy MSA.
+
+ """
+ residues = [res["res_type"] for res in residues]
+ deletions = []
+ sequences = [(0, -1, 0, len(residues), 0, 0)]
+ return MSA(
+ residues=np.array(residues, dtype=MSAResidue),
+ deletions=np.array(deletions, dtype=MSADeletion),
+ sequences=np.array(sequences, dtype=MSASequence),
+ )
+
+
+def construct_paired_msa( # noqa: C901, PLR0915, PLR0912
+ data: Tokenized,
+ max_seqs: int,
+ max_pairs: int = 8192,
+ max_total: int = 16384,
+ random_subset: bool = False,
+) -> tuple[Tensor, Tensor, Tensor]:
+ """Pair the MSA data.
+
+ Parameters
+ ----------
+ data : Input
+ The input data.
+
+ Returns
+ -------
+ Tensor
+ The MSA data.
+ Tensor
+ The deletion data.
+ Tensor
+ Mask indicating paired sequences.
+
+ """
+ # Get unique chains (ensuring monotonicity in the order)
+ assert np.all(np.diff(data.tokens["asym_id"], n=1) >= 0)
+ chain_ids = np.unique(data.tokens["asym_id"])
+
+ # Get relevant MSA, and create a dummy for chains without
+ msa = {k: data.msa[k] for k in chain_ids if k in data.msa}
+ for chain_id in chain_ids:
+ if chain_id not in msa:
+ chain = data.structure.chains[chain_id]
+ res_start = chain["res_idx"]
+ res_end = res_start + chain["res_num"]
+ residues = data.structure.residues[res_start:res_end]
+ msa[chain_id] = dummy_msa(residues)
+
+ # Map taxonomies to (chain_id, seq_idx)
+ taxonomy_map: dict[str, list] = {}
+ for chain_id, chain_msa in msa.items():
+ sequences = chain_msa.sequences
+ sequences = sequences[sequences["taxonomy"] != -1]
+ for sequence in sequences:
+ seq_idx = sequence["seq_idx"]
+ taxon = sequence["taxonomy"]
+ taxonomy_map.setdefault(taxon, []).append((chain_id, seq_idx))
+
+ # Remove taxonomies with only one sequence and sort by the
+ # number of chain_id present in each of the taxonomies
+ taxonomy_map = {k: v for k, v in taxonomy_map.items() if len(v) > 1}
+ taxonomy_map = sorted(
+ taxonomy_map.items(),
+ key=lambda x: len({c for c, _ in x[1]}),
+ reverse=True,
+ )
+
+ # Keep track of the sequences available per chain, keeping the original
+ # order of the sequences in the MSA to favor the best matching sequences
+ visited = {(c, s) for c, items in taxonomy_map for s in items}
+ available = {}
+ for c in chain_ids:
+ available[c] = deque(
+ i for i in range(1, len(msa[c].sequences)) if (c, i) not in visited
+ )
+
+ # Create sequence pairs
+ is_paired = []
+ pairing = []
+
+ # Start with the first sequence for each chain
+ is_paired.append({c: 1 for c in chain_ids})
+ pairing.append({c: 0 for c in chain_ids})
+
+ # Then add up to 8191 paired rows
+ for _, pairs in taxonomy_map:
+ # Group occurences by chain_id in case we have multiple
+ # sequences from the same chain and same taxonomy
+ chain_occurences = {}
+ for chain_id, seq_idx in pairs:
+ chain_occurences.setdefault(chain_id, []).append(seq_idx)
+
+ # We create as many pairings as the maximum number of occurences
+ max_occurences = max(len(v) for v in chain_occurences.values())
+ for i in range(max_occurences):
+ row_pairing = {}
+ row_is_paired = {}
+
+ # Add the chains present in the taxonomy
+ for chain_id, seq_idxs in chain_occurences.items():
+ # Roll over the sequence index to maximize diversity
+ idx = i % len(seq_idxs)
+ seq_idx = seq_idxs[idx]
+
+ # Add the sequence to the pairing
+ row_pairing[chain_id] = seq_idx
+ row_is_paired[chain_id] = 1
+
+ # Add any missing chains
+ for chain_id in chain_ids:
+ if chain_id not in row_pairing:
+ row_is_paired[chain_id] = 0
+ if available[chain_id]:
+ # Add the next available sequence
+ row_pairing[chain_id] = available[chain_id].popleft()
+ else:
+ # No more sequences available, we place a gap
+ row_pairing[chain_id] = -1
+
+ pairing.append(row_pairing)
+ is_paired.append(row_is_paired)
+
+ # Break if we have enough pairs
+ if len(pairing) >= max_pairs:
+ break
+
+ # Break if we have enough pairs
+ if len(pairing) >= max_pairs:
+ break
+
+ # Now add up to 16384 unpaired rows total
+ max_left = max(len(v) for v in available.values())
+ for _ in range(min(max_total - len(pairing), max_left)):
+ row_pairing = {}
+ row_is_paired = {}
+ for chain_id in chain_ids:
+ row_is_paired[chain_id] = 0
+ if available[chain_id]:
+ # Add the next available sequence
+ row_pairing[chain_id] = available[chain_id].popleft()
+ else:
+ # No more sequences available, we place a gap
+ row_pairing[chain_id] = -1
+
+ pairing.append(row_pairing)
+ is_paired.append(row_is_paired)
+
+ # Break if we have enough sequences
+ if len(pairing) >= max_total:
+ break
+
+ # Randomly sample a subset of the pairs
+ # ensuring the first row is always present
+ if random_subset:
+ num_seqs = len(pairing)
+ if num_seqs > max_seqs:
+ indices = np.random.choice(
+ list(range(1, num_seqs)), size=max_seqs - 1, replace=False
+ ) # noqa: NPY002
+ pairing = [pairing[0]] + [pairing[i] for i in indices]
+ is_paired = [is_paired[0]] + [is_paired[i] for i in indices]
+ else:
+ # Deterministic downsample to max_seqs
+ pairing = pairing[:max_seqs]
+ is_paired = is_paired[:max_seqs]
+
+ # Map (chain_id, seq_idx, res_idx) to deletion
+ deletions = numba.typed.Dict.empty(
+ key_type=numba.types.Tuple(
+ [numba.types.int64, numba.types.int64, numba.types.int64]),
+ value_type=numba.types.int64
+ )
+ for chain_id, chain_msa in msa.items():
+ chain_deletions = chain_msa.deletions
+ for sequence in chain_msa.sequences:
+ seq_idx = sequence["seq_idx"]
+ del_start = sequence["del_start"]
+ del_end = sequence["del_end"]
+ chain_deletions = chain_deletions[del_start:del_end]
+ for deletion_data in chain_deletions:
+ res_idx = deletion_data["res_idx"]
+ deletion_values = deletion_data["deletion"]
+ deletions[(chain_id, seq_idx, res_idx)] = deletion_values
+
+ # Add all the token MSA data
+ msa_data, del_data, paired_data = prepare_msa_arrays(
+ data.tokens, pairing, is_paired, deletions, msa
+ )
+
+ msa_data = torch.tensor(msa_data, dtype=torch.long)
+ del_data = torch.tensor(del_data, dtype=torch.float)
+ paired_data = torch.tensor(paired_data, dtype=torch.float)
+
+ return msa_data, del_data, paired_data
+
+
+def prepare_msa_arrays(
+ tokens,
+ pairing: list[dict[int, int]],
+ is_paired: list[dict[int, int]],
+ deletions: dict[tuple[int, int, int], int],
+ msa: dict[int, MSA],
+) -> tuple[npt.NDArray[np.int64], npt.NDArray[np.int64], npt.NDArray[np.int64]]:
+ """Reshape data to play nicely with numba jit."""
+ token_asym_ids_arr = np.array([t["asym_id"] for t in tokens], dtype=np.int64)
+ token_res_idxs_arr = np.array([t["res_idx"] for t in tokens], dtype=np.int64)
+
+ chain_ids = sorted(msa.keys())
+
+ # chain_ids are not necessarily contiguous (e.g. they might be 0, 24, 25).
+ # This allows us to look up a chain_id by it's index in the chain_ids list.
+ chain_id_to_idx = {chain_id: i for i, chain_id in enumerate(chain_ids)}
+ token_asym_ids_idx_arr = np.array(
+ [chain_id_to_idx[asym_id] for asym_id in token_asym_ids_arr], dtype=np.int64
+ )
+
+ pairing_arr = np.zeros((len(pairing), len(chain_ids)), dtype=np.int64)
+ is_paired_arr = np.zeros((len(is_paired), len(chain_ids)), dtype=np.int64)
+
+ for i, row_pairing in enumerate(pairing):
+ for chain_id in chain_ids:
+ pairing_arr[i, chain_id_to_idx[chain_id]] = row_pairing[chain_id]
+
+ for i, row_is_paired in enumerate(is_paired):
+ for chain_id in chain_ids:
+ is_paired_arr[i, chain_id_to_idx[chain_id]] = row_is_paired[chain_id]
+
+ max_seq_len = max(len(msa[chain_id].sequences) for chain_id in chain_ids)
+
+ # we want res_start from sequences
+ msa_sequences = np.full((len(chain_ids), max_seq_len), -1, dtype=np.int64)
+ for chain_id in chain_ids:
+ for i, seq in enumerate(msa[chain_id].sequences):
+ msa_sequences[chain_id_to_idx[chain_id], i] = seq["res_start"]
+
+ max_residues_len = max(len(msa[chain_id].residues) for chain_id in chain_ids)
+ msa_residues = np.full((len(chain_ids), max_residues_len), -1, dtype=np.int64)
+ for chain_id in chain_ids:
+ residues = msa[chain_id].residues.astype(np.int64)
+ idxs = np.arange(len(residues))
+ chain_idx = chain_id_to_idx[chain_id]
+ msa_residues[chain_idx, idxs] = residues
+
+ return _prepare_msa_arrays_inner(
+ token_asym_ids_arr,
+ token_res_idxs_arr,
+ token_asym_ids_idx_arr,
+ pairing_arr,
+ is_paired_arr,
+ deletions,
+ msa_sequences,
+ msa_residues,
+ const.token_ids["-"],
+ )
+
+
+deletions_dict_type = types.DictType(types.UniTuple(types.int64, 3), types.int64)
+
+
+@numba.njit(
+ [
+ types.Tuple(
+ (
+ types.int64[:, ::1], # msa_data
+ types.int64[:, ::1], # del_data
+ types.int64[:, ::1], # paired_data
+ )
+ )(
+ types.int64[::1], # token_asym_ids
+ types.int64[::1], # token_res_idxs
+ types.int64[::1], # token_asym_ids_idx
+ types.int64[:, ::1], # pairing
+ types.int64[:, ::1], # is_paired
+ deletions_dict_type, # deletions
+ types.int64[:, ::1], # msa_sequences
+ types.int64[:, ::1], # msa_residues
+ types.int64, # gap_token
+ )
+ ],
+ cache=True,
+)
+def _prepare_msa_arrays_inner(
+ token_asym_ids: npt.NDArray[np.int64],
+ token_res_idxs: npt.NDArray[np.int64],
+ token_asym_ids_idx: npt.NDArray[np.int64],
+ pairing: npt.NDArray[np.int64],
+ is_paired: npt.NDArray[np.int64],
+ deletions: dict[tuple[int, int, int], int],
+ msa_sequences: npt.NDArray[np.int64],
+ msa_residues: npt.NDArray[np.int64],
+ gap_token: int,
+) -> tuple[npt.NDArray[np.int64], npt.NDArray[np.int64], npt.NDArray[np.int64]]:
+ n_tokens = len(token_asym_ids)
+ n_pairs = len(pairing)
+ msa_data = np.full((n_tokens, n_pairs), gap_token, dtype=np.int64)
+ paired_data = np.zeros((n_tokens, n_pairs), dtype=np.int64)
+ del_data = np.zeros((n_tokens, n_pairs), dtype=np.int64)
+
+ # Add all the token MSA data
+ for token_idx in range(n_tokens):
+ chain_id_idx = token_asym_ids_idx[token_idx]
+ chain_id = token_asym_ids[token_idx]
+ res_idx = token_res_idxs[token_idx]
+
+ for pair_idx in range(n_pairs):
+ seq_idx = pairing[pair_idx, chain_id_idx]
+ paired_data[token_idx, pair_idx] = is_paired[pair_idx, chain_id_idx]
+
+ # Add residue type
+ if seq_idx != -1:
+ res_start = msa_sequences[chain_id_idx, seq_idx]
+ res_type = msa_residues[chain_id_idx, res_start + res_idx]
+ k = (chain_id, seq_idx, res_idx)
+ if k in deletions:
+ del_data[token_idx, pair_idx] = deletions[k]
+ msa_data[token_idx, pair_idx] = res_type
+
+ return msa_data, del_data, paired_data
+
+
+####################################################################################################
+# FEATURES
+####################################################################################################
+
+
+def select_subset_from_mask(mask, p):
+ num_true = np.sum(mask)
+ v = np.random.geometric(p) + 1
+ k = min(v, num_true)
+
+ true_indices = np.where(mask)[0]
+
+ # Randomly select k indices from the true_indices
+ selected_indices = np.random.choice(true_indices, size=k, replace=False)
+
+ new_mask = np.zeros_like(mask)
+ new_mask[selected_indices] = 1
+
+ return new_mask
+
+
+def process_token_features(
+ data: Tokenized,
+ max_tokens: Optional[int] = None,
+ binder_pocket_conditioned_prop: Optional[float] = 0.0,
+ binder_pocket_cutoff: Optional[float] = 6.0,
+ binder_pocket_sampling_geometric_p: Optional[float] = 0.0,
+ only_ligand_binder_pocket: Optional[bool] = False,
+ inference_binder: Optional[list[int]] = None,
+ inference_pocket: Optional[list[tuple[int, int]]] = None,
+) -> dict[str, Tensor]:
+ """Get the token features.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The tokenized data.
+ max_tokens : int
+ The maximum number of tokens.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The token features.
+
+ """
+ # Token data
+ token_data = data.tokens
+ token_bonds = data.bonds
+
+ # Token core features
+ token_index = torch.arange(len(token_data), dtype=torch.long)
+ residue_index = from_numpy(token_data["res_idx"].copy()).long()
+ asym_id = from_numpy(token_data["asym_id"].copy()).long()
+ entity_id = from_numpy(token_data["entity_id"].copy()).long()
+ sym_id = from_numpy(token_data["sym_id"].copy()).long()
+ mol_type = from_numpy(token_data["mol_type"].copy()).long()
+ res_type = from_numpy(token_data["res_type"].copy()).long()
+ res_type = one_hot(res_type, num_classes=const.num_tokens)
+ disto_center = from_numpy(token_data["disto_coords"].copy())
+
+ # Token mask features
+ pad_mask = torch.ones(len(token_data), dtype=torch.float)
+ resolved_mask = from_numpy(token_data["resolved_mask"].copy()).float()
+ disto_mask = from_numpy(token_data["disto_mask"].copy()).float()
+ cyclic_period = from_numpy(token_data["cyclic_period"].copy())
+
+ # Token bond features
+ if max_tokens is not None:
+ pad_len = max_tokens - len(token_data)
+ num_tokens = max_tokens if pad_len > 0 else len(token_data)
+ else:
+ num_tokens = len(token_data)
+
+ tok_to_idx = {tok["token_idx"]: idx for idx, tok in enumerate(token_data)}
+ bonds = torch.zeros(num_tokens, num_tokens, dtype=torch.float)
+ for token_bond in token_bonds:
+ token_1 = tok_to_idx[token_bond["token_1"]]
+ token_2 = tok_to_idx[token_bond["token_2"]]
+ bonds[token_1, token_2] = 1
+ bonds[token_2, token_1] = 1
+
+ bonds = bonds.unsqueeze(-1)
+
+ # Pocket conditioned feature
+ pocket_feature = (
+ np.zeros(len(token_data)) + const.pocket_contact_info["UNSPECIFIED"]
+ )
+ if inference_binder is not None:
+ assert inference_pocket is not None
+ pocket_residues = set(inference_pocket)
+ for idx, token in enumerate(token_data):
+ if token["asym_id"] in inference_binder:
+ pocket_feature[idx] = const.pocket_contact_info["BINDER"]
+ elif (token["asym_id"], token["res_idx"]) in pocket_residues:
+ pocket_feature[idx] = const.pocket_contact_info["POCKET"]
+ else:
+ pocket_feature[idx] = const.pocket_contact_info["UNSELECTED"]
+ elif (
+ binder_pocket_conditioned_prop > 0.0
+ and random.random() < binder_pocket_conditioned_prop
+ ):
+ # choose as binder a random ligand in the crop, if there are no ligands select a protein chain
+ binder_asym_ids = np.unique(
+ token_data["asym_id"][
+ token_data["mol_type"] == const.chain_type_ids["NONPOLYMER"]
+ ]
+ )
+
+ if len(binder_asym_ids) == 0:
+ if not only_ligand_binder_pocket:
+ binder_asym_ids = np.unique(token_data["asym_id"])
+
+ if len(binder_asym_ids) > 0:
+ pocket_asym_id = random.choice(binder_asym_ids)
+ binder_mask = token_data["asym_id"] == pocket_asym_id
+
+ binder_coords = []
+ for token in token_data:
+ if token["asym_id"] == pocket_asym_id:
+ binder_coords.append(
+ data.structure.atoms["coords"][
+ token["atom_idx"] : token["atom_idx"] + token["atom_num"]
+ ]
+ )
+ binder_coords = np.concatenate(binder_coords, axis=0)
+
+ # find the tokens in the pocket
+ token_dist = np.zeros(len(token_data)) + 1000
+ for i, token in enumerate(token_data):
+ if (
+ token["mol_type"] != const.chain_type_ids["NONPOLYMER"]
+ and token["asym_id"] != pocket_asym_id
+ and token["resolved_mask"] == 1
+ ):
+ token_coords = data.structure.atoms["coords"][
+ token["atom_idx"] : token["atom_idx"] + token["atom_num"]
+ ]
+
+ # find chain and apply chain transformation
+ for chain in data.structure.chains:
+ if chain["asym_id"] == token["asym_id"]:
+ break
+
+ token_dist[i] = np.min(
+ np.linalg.norm(
+ token_coords[:, None, :] - binder_coords[None, :, :],
+ axis=-1,
+ )
+ )
+
+ pocket_mask = token_dist < binder_pocket_cutoff
+
+ if np.sum(pocket_mask) > 0:
+ pocket_feature = (
+ np.zeros(len(token_data)) + const.pocket_contact_info["UNSELECTED"]
+ )
+ pocket_feature[binder_mask] = const.pocket_contact_info["BINDER"]
+
+ if binder_pocket_sampling_geometric_p > 0.0:
+ # select a subset of the pocket, according
+ # to a geometric distribution with one as minimum
+ pocket_mask = select_subset_from_mask(
+ pocket_mask, binder_pocket_sampling_geometric_p
+ )
+
+ pocket_feature[pocket_mask] = const.pocket_contact_info["POCKET"]
+ pocket_feature = from_numpy(pocket_feature).long()
+ pocket_feature = one_hot(pocket_feature, num_classes=len(const.pocket_contact_info))
+
+ # Pad to max tokens if given
+ if max_tokens is not None:
+ pad_len = max_tokens - len(token_data)
+ if pad_len > 0:
+ token_index = pad_dim(token_index, 0, pad_len)
+ residue_index = pad_dim(residue_index, 0, pad_len)
+ asym_id = pad_dim(asym_id, 0, pad_len)
+ entity_id = pad_dim(entity_id, 0, pad_len)
+ sym_id = pad_dim(sym_id, 0, pad_len)
+ mol_type = pad_dim(mol_type, 0, pad_len)
+ res_type = pad_dim(res_type, 0, pad_len)
+ disto_center = pad_dim(disto_center, 0, pad_len)
+ pad_mask = pad_dim(pad_mask, 0, pad_len)
+ resolved_mask = pad_dim(resolved_mask, 0, pad_len)
+ disto_mask = pad_dim(disto_mask, 0, pad_len)
+ pocket_feature = pad_dim(pocket_feature, 0, pad_len)
+
+ token_features = {
+ "token_index": token_index,
+ "residue_index": residue_index,
+ "asym_id": asym_id,
+ "entity_id": entity_id,
+ "sym_id": sym_id,
+ "mol_type": mol_type,
+ "res_type": res_type,
+ "disto_center": disto_center,
+ "token_bonds": bonds,
+ "token_pad_mask": pad_mask,
+ "token_resolved_mask": resolved_mask,
+ "token_disto_mask": disto_mask,
+ "pocket_feature": pocket_feature,
+ "cyclic_period": cyclic_period,
+ }
+ return token_features
+
+
+def process_atom_features(
+ data: Tokenized,
+ atoms_per_window_queries: int = 32,
+ min_dist: float = 2.0,
+ max_dist: float = 22.0,
+ num_bins: int = 64,
+ max_atoms: Optional[int] = None,
+ max_tokens: Optional[int] = None,
+) -> dict[str, Tensor]:
+ """Get the atom features.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The tokenized data.
+ max_atoms : int, optional
+ The maximum number of atoms.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The atom features.
+
+ """
+ # Filter to tokens' atoms
+ atom_data = []
+ ref_space_uid = []
+ coord_data = []
+ frame_data = []
+ resolved_frame_data = []
+ atom_to_token = []
+ token_to_rep_atom = [] # index on cropped atom table
+ r_set_to_rep_atom = []
+ disto_coords = []
+ atom_idx = 0
+
+ chain_res_ids = {}
+ for token_id, token in enumerate(data.tokens):
+ # Get the chain residue ids
+ chain_idx, res_id = token["asym_id"], token["res_idx"]
+ chain = data.structure.chains[chain_idx]
+
+ if (chain_idx, res_id) not in chain_res_ids:
+ new_idx = len(chain_res_ids)
+ chain_res_ids[(chain_idx, res_id)] = new_idx
+ else:
+ new_idx = chain_res_ids[(chain_idx, res_id)]
+
+ # Map atoms to token indices
+ ref_space_uid.extend([new_idx] * token["atom_num"])
+ atom_to_token.extend([token_id] * token["atom_num"])
+
+ # Add atom data
+ start = token["atom_idx"]
+ end = token["atom_idx"] + token["atom_num"]
+ token_atoms = data.structure.atoms[start:end]
+
+ # Map token to representative atom
+ token_to_rep_atom.append(atom_idx + token["disto_idx"] - start)
+ if (chain["mol_type"] != const.chain_type_ids["NONPOLYMER"]) and token[
+ "resolved_mask"
+ ]:
+ r_set_to_rep_atom.append(atom_idx + token["center_idx"] - start)
+
+ # Get token coordinates
+ token_coords = np.array([token_atoms["coords"]])
+ coord_data.append(token_coords)
+
+ # Get frame data
+ res_type = const.tokens[token["res_type"]]
+
+ if token["atom_num"] < 3 or res_type in ["PAD", "UNK", "-"]:
+ idx_frame_a, idx_frame_b, idx_frame_c = 0, 0, 0
+ mask_frame = False
+ elif (token["mol_type"] == const.chain_type_ids["PROTEIN"]) and (
+ res_type in const.ref_atoms
+ ):
+ idx_frame_a, idx_frame_b, idx_frame_c = (
+ const.ref_atoms[res_type].index("N"),
+ const.ref_atoms[res_type].index("CA"),
+ const.ref_atoms[res_type].index("C"),
+ )
+ mask_frame = (
+ token_atoms["is_present"][idx_frame_a]
+ and token_atoms["is_present"][idx_frame_b]
+ and token_atoms["is_present"][idx_frame_c]
+ )
+ elif (
+ token["mol_type"] == const.chain_type_ids["DNA"]
+ or token["mol_type"] == const.chain_type_ids["RNA"]
+ ) and (res_type in const.ref_atoms):
+ idx_frame_a, idx_frame_b, idx_frame_c = (
+ const.ref_atoms[res_type].index("C1'"),
+ const.ref_atoms[res_type].index("C3'"),
+ const.ref_atoms[res_type].index("C4'"),
+ )
+ mask_frame = (
+ token_atoms["is_present"][idx_frame_a]
+ and token_atoms["is_present"][idx_frame_b]
+ and token_atoms["is_present"][idx_frame_c]
+ )
+ else:
+ idx_frame_a, idx_frame_b, idx_frame_c = 0, 0, 0
+ mask_frame = False
+ frame_data.append(
+ [idx_frame_a + atom_idx, idx_frame_b + atom_idx, idx_frame_c + atom_idx]
+ )
+ resolved_frame_data.append(mask_frame)
+
+ # Get distogram coordinates
+ disto_coords_tok = data.structure.atoms[token["disto_idx"]]["coords"]
+ disto_coords.append(disto_coords_tok)
+
+ # Update atom data. This is technically never used again (we rely on coord_data),
+ # but we update for consistency and to make sure the Atom object has valid, transformed coordinates.
+ token_atoms = token_atoms.copy()
+ token_atoms["coords"] = token_coords[0] # atom has a copy of first coords
+ atom_data.append(token_atoms)
+ atom_idx += len(token_atoms)
+
+ disto_coords = np.array(disto_coords)
+
+ # Compute distogram
+ t_center = torch.Tensor(disto_coords)
+ t_dists = torch.cdist(t_center, t_center)
+ boundaries = torch.linspace(min_dist, max_dist, num_bins - 1)
+ distogram = (t_dists.unsqueeze(-1) > boundaries).sum(dim=-1).long()
+ disto_target = one_hot(distogram, num_classes=num_bins)
+
+ atom_data = np.concatenate(atom_data)
+ coord_data = np.concatenate(coord_data, axis=1)
+ ref_space_uid = np.array(ref_space_uid)
+
+ # Compute features
+ ref_atom_name_chars = from_numpy(atom_data["name"]).long()
+ ref_element = from_numpy(atom_data["element"]).long()
+ ref_charge = from_numpy(atom_data["charge"])
+ ref_pos = from_numpy(
+ atom_data["conformer"].copy()
+ ) # not sure why I need to copy here..
+ ref_space_uid = from_numpy(ref_space_uid)
+ coords = from_numpy(coord_data.copy())
+ resolved_mask = from_numpy(atom_data["is_present"])
+ pad_mask = torch.ones(len(atom_data), dtype=torch.float)
+ atom_to_token = torch.tensor(atom_to_token, dtype=torch.long)
+ token_to_rep_atom = torch.tensor(token_to_rep_atom, dtype=torch.long)
+ r_set_to_rep_atom = torch.tensor(r_set_to_rep_atom, dtype=torch.long)
+ frame_data, resolved_frame_data = compute_frames_nonpolymer(
+ data,
+ coord_data,
+ atom_data["is_present"],
+ atom_to_token,
+ frame_data,
+ resolved_frame_data,
+ ) # Compute frames for NONPOLYMER tokens
+ frames = from_numpy(frame_data.copy())
+ frame_resolved_mask = from_numpy(resolved_frame_data.copy())
+ # Convert to one-hot
+ ref_atom_name_chars = one_hot(
+ ref_atom_name_chars % num_bins, num_classes=num_bins
+ ) # added for lower case letters
+ ref_element = one_hot(ref_element, num_classes=const.num_elements)
+ atom_to_token = one_hot(atom_to_token, num_classes=token_id + 1)
+ token_to_rep_atom = one_hot(token_to_rep_atom, num_classes=len(atom_data))
+ r_set_to_rep_atom = one_hot(r_set_to_rep_atom, num_classes=len(atom_data))
+
+ # Center the ground truth coordinates
+ center = (coords * resolved_mask[None, :, None]).sum(dim=1)
+ center = center / resolved_mask.sum().clamp(min=1)
+ coords = coords - center[:, None]
+
+ # Apply random roto-translation to the input atoms
+ ref_pos = center_random_augmentation(
+ ref_pos[None], resolved_mask[None], centering=False
+ )[0]
+
+ # Compute padding and apply
+ if max_atoms is not None:
+ assert max_atoms % atoms_per_window_queries == 0
+ pad_len = max_atoms - len(atom_data)
+ else:
+ pad_len = (
+ (len(atom_data) - 1) // atoms_per_window_queries + 1
+ ) * atoms_per_window_queries - len(atom_data)
+
+ if pad_len > 0:
+ pad_mask = pad_dim(pad_mask, 0, pad_len)
+ ref_pos = pad_dim(ref_pos, 0, pad_len)
+ resolved_mask = pad_dim(resolved_mask, 0, pad_len)
+ ref_element = pad_dim(ref_element, 0, pad_len)
+ ref_charge = pad_dim(ref_charge, 0, pad_len)
+ ref_atom_name_chars = pad_dim(ref_atom_name_chars, 0, pad_len)
+ ref_space_uid = pad_dim(ref_space_uid, 0, pad_len)
+ coords = pad_dim(coords, 1, pad_len)
+ atom_to_token = pad_dim(atom_to_token, 0, pad_len)
+ token_to_rep_atom = pad_dim(token_to_rep_atom, 1, pad_len)
+ r_set_to_rep_atom = pad_dim(r_set_to_rep_atom, 1, pad_len)
+
+ if max_tokens is not None:
+ pad_len = max_tokens - token_to_rep_atom.shape[0]
+ if pad_len > 0:
+ atom_to_token = pad_dim(atom_to_token, 1, pad_len)
+ token_to_rep_atom = pad_dim(token_to_rep_atom, 0, pad_len)
+ r_set_to_rep_atom = pad_dim(r_set_to_rep_atom, 0, pad_len)
+ disto_target = pad_dim(pad_dim(disto_target, 0, pad_len), 1, pad_len)
+ frames = pad_dim(frames, 0, pad_len)
+ frame_resolved_mask = pad_dim(frame_resolved_mask, 0, pad_len)
+
+ return {
+ "ref_pos": ref_pos,
+ "atom_resolved_mask": resolved_mask,
+ "ref_element": ref_element,
+ "ref_charge": ref_charge,
+ "ref_atom_name_chars": ref_atom_name_chars,
+ "ref_space_uid": ref_space_uid,
+ "coords": coords,
+ "atom_pad_mask": pad_mask,
+ "atom_to_token": atom_to_token,
+ "token_to_rep_atom": token_to_rep_atom,
+ "r_set_to_rep_atom": r_set_to_rep_atom,
+ "disto_target": disto_target,
+ "frames_idx": frames,
+ "frame_resolved_mask": frame_resolved_mask,
+ }
+
+
+def process_msa_features(
+ data: Tokenized,
+ max_seqs_batch: int,
+ max_seqs: int,
+ max_tokens: Optional[int] = None,
+ pad_to_max_seqs: bool = False,
+) -> dict[str, Tensor]:
+ """Get the MSA features.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The tokenized data.
+ max_seqs : int
+ The maximum number of MSA sequences.
+ max_tokens : int
+ The maximum number of tokens.
+ pad_to_max_seqs : bool
+ Whether to pad to the maximum number of sequences.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The MSA features.
+
+ """
+ # Created paired MSA
+ msa, deletion, paired = construct_paired_msa(data, max_seqs_batch)
+ msa, deletion, paired = (
+ msa.transpose(1, 0),
+ deletion.transpose(1, 0),
+ paired.transpose(1, 0),
+ ) # (N_MSA, N_RES, N_AA)
+
+ # Prepare features
+ msa = torch.nn.functional.one_hot(msa, num_classes=const.num_tokens)
+ msa_mask = torch.ones_like(msa[:, :, 0])
+ profile = msa.float().mean(dim=0)
+ has_deletion = deletion > 0
+ deletion = np.pi / 2 * np.arctan(deletion / 3)
+ deletion_mean = deletion.mean(axis=0)
+
+ # Pad in the MSA dimension (dim=0)
+ if pad_to_max_seqs:
+ pad_len = max_seqs - msa.shape[0]
+ if pad_len > 0:
+ msa = pad_dim(msa, 0, pad_len, const.token_ids["-"])
+ paired = pad_dim(paired, 0, pad_len)
+ msa_mask = pad_dim(msa_mask, 0, pad_len)
+ has_deletion = pad_dim(has_deletion, 0, pad_len)
+ deletion = pad_dim(deletion, 0, pad_len)
+
+ # Pad in the token dimension (dim=1)
+ if max_tokens is not None:
+ pad_len = max_tokens - msa.shape[1]
+ if pad_len > 0:
+ msa = pad_dim(msa, 1, pad_len, const.token_ids["-"])
+ paired = pad_dim(paired, 1, pad_len)
+ msa_mask = pad_dim(msa_mask, 1, pad_len)
+ has_deletion = pad_dim(has_deletion, 1, pad_len)
+ deletion = pad_dim(deletion, 1, pad_len)
+ profile = pad_dim(profile, 0, pad_len)
+ deletion_mean = pad_dim(deletion_mean, 0, pad_len)
+
+ return {
+ "msa": msa,
+ "msa_paired": paired,
+ "deletion_value": deletion,
+ "has_deletion": has_deletion,
+ "deletion_mean": deletion_mean,
+ "profile": profile,
+ "msa_mask": msa_mask,
+ }
+
+
+def process_symmetry_features(
+ cropped: Tokenized, symmetries: dict
+) -> dict[str, Tensor]:
+ """Get the symmetry features.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The tokenized data.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The symmetry features.
+
+ """
+ features = get_chain_symmetries(cropped)
+ features.update(get_amino_acids_symmetries(cropped))
+ features.update(get_ligand_symmetries(cropped, symmetries))
+
+ return features
+
+
+def process_residue_constraint_features(
+ data: Tokenized,
+) -> dict[str, Tensor]:
+ residue_constraints = data.residue_constraints
+ if residue_constraints is not None:
+ rdkit_bounds_constraints = residue_constraints.rdkit_bounds_constraints
+ chiral_atom_constraints = residue_constraints.chiral_atom_constraints
+ stereo_bond_constraints = residue_constraints.stereo_bond_constraints
+ planar_bond_constraints = residue_constraints.planar_bond_constraints
+ planar_ring_5_constraints = residue_constraints.planar_ring_5_constraints
+ planar_ring_6_constraints = residue_constraints.planar_ring_6_constraints
+
+ rdkit_bounds_index = torch.tensor(
+ rdkit_bounds_constraints["atom_idxs"].copy(), dtype=torch.long
+ ).T
+ rdkit_bounds_bond_mask = torch.tensor(
+ rdkit_bounds_constraints["is_bond"].copy(), dtype=torch.bool
+ )
+ rdkit_bounds_angle_mask = torch.tensor(
+ rdkit_bounds_constraints["is_angle"].copy(), dtype=torch.bool
+ )
+ rdkit_upper_bounds = torch.tensor(
+ rdkit_bounds_constraints["upper_bound"].copy(), dtype=torch.float
+ )
+ rdkit_lower_bounds = torch.tensor(
+ rdkit_bounds_constraints["lower_bound"].copy(), dtype=torch.float
+ )
+
+ chiral_atom_index = torch.tensor(
+ chiral_atom_constraints["atom_idxs"].copy(), dtype=torch.long
+ ).T
+ chiral_reference_mask = torch.tensor(
+ chiral_atom_constraints["is_reference"].copy(), dtype=torch.bool
+ )
+ chiral_atom_orientations = torch.tensor(
+ chiral_atom_constraints["is_r"].copy(), dtype=torch.bool
+ )
+
+ stereo_bond_index = torch.tensor(
+ stereo_bond_constraints["atom_idxs"].copy(), dtype=torch.long
+ ).T
+ stereo_reference_mask = torch.tensor(
+ stereo_bond_constraints["is_reference"].copy(), dtype=torch.bool
+ )
+ stereo_bond_orientations = torch.tensor(
+ stereo_bond_constraints["is_e"].copy(), dtype=torch.bool
+ )
+
+ planar_bond_index = torch.tensor(
+ planar_bond_constraints["atom_idxs"].copy(), dtype=torch.long
+ ).T
+ planar_ring_5_index = torch.tensor(
+ planar_ring_5_constraints["atom_idxs"].copy(), dtype=torch.long
+ ).T
+ planar_ring_6_index = torch.tensor(
+ planar_ring_6_constraints["atom_idxs"].copy(), dtype=torch.long
+ ).T
+ else:
+ rdkit_bounds_index = torch.empty((2, 0), dtype=torch.long)
+ rdkit_bounds_bond_mask = torch.empty((0,), dtype=torch.bool)
+ rdkit_bounds_angle_mask = torch.empty((0,), dtype=torch.bool)
+ rdkit_upper_bounds = torch.empty((0,), dtype=torch.float)
+ rdkit_lower_bounds = torch.empty((0,), dtype=torch.float)
+ chiral_atom_index = torch.empty(
+ (
+ 4,
+ 0,
+ ),
+ dtype=torch.long,
+ )
+ chiral_reference_mask = torch.empty((0,), dtype=torch.bool)
+ chiral_atom_orientations = torch.empty((0,), dtype=torch.bool)
+ stereo_bond_index = torch.empty((4, 0), dtype=torch.long)
+ stereo_reference_mask = torch.empty((0,), dtype=torch.bool)
+ stereo_bond_orientations = torch.empty((0,), dtype=torch.bool)
+ planar_bond_index = torch.empty((6, 0), dtype=torch.long)
+ planar_ring_5_index = torch.empty((5, 0), dtype=torch.long)
+ planar_ring_6_index = torch.empty((6, 0), dtype=torch.long)
+
+ return {
+ "rdkit_bounds_index": rdkit_bounds_index,
+ "rdkit_bounds_bond_mask": rdkit_bounds_bond_mask,
+ "rdkit_bounds_angle_mask": rdkit_bounds_angle_mask,
+ "rdkit_upper_bounds": rdkit_upper_bounds,
+ "rdkit_lower_bounds": rdkit_lower_bounds,
+ "chiral_atom_index": chiral_atom_index,
+ "chiral_reference_mask": chiral_reference_mask,
+ "chiral_atom_orientations": chiral_atom_orientations,
+ "stereo_bond_index": stereo_bond_index,
+ "stereo_reference_mask": stereo_reference_mask,
+ "stereo_bond_orientations": stereo_bond_orientations,
+ "planar_bond_index": planar_bond_index,
+ "planar_ring_5_index": planar_ring_5_index,
+ "planar_ring_6_index": planar_ring_6_index,
+ }
+
+
+def process_chain_feature_constraints(
+ data: Tokenized,
+) -> dict[str, Tensor]:
+ structure = data.structure
+ if structure.connections.shape[0] > 0:
+ connected_chain_index, connected_atom_index = [], []
+ for connection in structure.connections:
+ connected_chain_index.append([connection["chain_1"], connection["chain_2"]])
+ connected_atom_index.append([connection["atom_1"], connection["atom_2"]])
+ connected_chain_index = torch.tensor(connected_chain_index, dtype=torch.long).T
+ connected_atom_index = torch.tensor(connected_atom_index, dtype=torch.long).T
+ else:
+ connected_chain_index = torch.empty((2, 0), dtype=torch.long)
+ connected_atom_index = torch.empty((2, 0), dtype=torch.long)
+
+ symmetric_chain_index = []
+ for i, chain_i in enumerate(structure.chains):
+ for j, chain_j in enumerate(structure.chains):
+ if j <= i:
+ continue
+ if chain_i["entity_id"] == chain_j["entity_id"]:
+ symmetric_chain_index.append([i, j])
+ if len(symmetric_chain_index) > 0:
+ symmetric_chain_index = torch.tensor(symmetric_chain_index, dtype=torch.long).T
+ else:
+ symmetric_chain_index = torch.empty((2, 0), dtype=torch.long)
+ return {
+ "connected_chain_index": connected_chain_index,
+ "connected_atom_index": connected_atom_index,
+ "symmetric_chain_index": symmetric_chain_index,
+ }
+
+
+class BoltzFeaturizer:
+ """Boltz featurizer."""
+
+ def process(
+ self,
+ data: Tokenized,
+ training: bool,
+ max_seqs: int = 4096,
+ atoms_per_window_queries: int = 32,
+ min_dist: float = 2.0,
+ max_dist: float = 22.0,
+ num_bins: int = 64,
+ max_tokens: Optional[int] = None,
+ max_atoms: Optional[int] = None,
+ pad_to_max_seqs: bool = False,
+ compute_symmetries: bool = False,
+ symmetries: Optional[dict] = None,
+ binder_pocket_conditioned_prop: Optional[float] = 0.0,
+ binder_pocket_cutoff: Optional[float] = 6.0,
+ binder_pocket_sampling_geometric_p: Optional[float] = 0.0,
+ only_ligand_binder_pocket: Optional[bool] = False,
+ inference_binder: Optional[int] = None,
+ inference_pocket: Optional[list[tuple[int, int]]] = None,
+ compute_constraint_features: bool = False,
+ ) -> dict[str, Tensor]:
+ """Compute features.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The tokenized data.
+ training : bool
+ Whether the model is in training mode.
+ max_tokens : int, optional
+ The maximum number of tokens.
+ max_atoms : int, optional
+ The maximum number of atoms
+ max_seqs : int, optional
+ The maximum number of sequences.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The features for model training.
+
+ """
+ # Compute random number of sequences
+ if training and max_seqs is not None:
+ max_seqs_batch = np.random.randint(1, max_seqs + 1) # noqa: NPY002
+ else:
+ max_seqs_batch = max_seqs
+
+ # Compute token features
+ token_features = process_token_features(
+ data,
+ max_tokens,
+ binder_pocket_conditioned_prop,
+ binder_pocket_cutoff,
+ binder_pocket_sampling_geometric_p,
+ only_ligand_binder_pocket,
+ inference_binder=inference_binder,
+ inference_pocket=inference_pocket,
+ )
+
+ # Compute atom features
+ atom_features = process_atom_features(
+ data,
+ atoms_per_window_queries,
+ min_dist,
+ max_dist,
+ num_bins,
+ max_atoms,
+ max_tokens,
+ )
+
+ # Compute MSA features
+ msa_features = process_msa_features(
+ data,
+ max_seqs_batch,
+ max_seqs,
+ max_tokens,
+ pad_to_max_seqs,
+ )
+
+ # Compute symmetry features
+ symmetry_features = {}
+ if compute_symmetries:
+ symmetry_features = process_symmetry_features(data, symmetries)
+
+ # Compute constraint features
+ residue_constraint_features = {}
+ chain_constraint_features = {}
+ if compute_constraint_features:
+ residue_constraint_features = process_residue_constraint_features(data)
+ chain_constraint_features = process_chain_feature_constraints(data)
+
+ return {
+ **token_features,
+ **atom_features,
+ **msa_features,
+ **symmetry_features,
+ **residue_constraint_features,
+ **chain_constraint_features,
+ }
diff --git a/forks/boltz/src/boltz/data/feature/featurizerv2.py b/forks/boltz/src/boltz/data/feature/featurizerv2.py
new file mode 100644
index 00000000..b6bea5e4
--- /dev/null
+++ b/forks/boltz/src/boltz/data/feature/featurizerv2.py
@@ -0,0 +1,2354 @@
+import math
+from typing import Optional
+from collections import deque
+import numba
+import numpy as np
+import numpy.typing as npt
+import rdkit.Chem.Descriptors
+import torch
+from numba import types
+from rdkit.Chem import Mol
+from scipy.spatial.distance import cdist
+from torch import Tensor, from_numpy
+from torch.nn.functional import one_hot
+
+from boltz.data import const
+from boltz.data.mol import (
+ get_amino_acids_symmetries,
+ get_chain_symmetries,
+ get_ligand_symmetries,
+ get_symmetries,
+)
+from boltz.data.pad import pad_dim
+from boltz.data.types import (
+ MSA,
+ MSADeletion,
+ MSAResidue,
+ MSASequence,
+ TemplateInfo,
+ Tokenized,
+)
+from boltz.model.modules.utils import center_random_augmentation
+
+####################################################################################################
+# HELPERS
+####################################################################################################
+
+
+def convert_atom_name(name: str) -> tuple[int, int, int, int]:
+ """Convert an atom name to a standard format.
+
+ Parameters
+ ----------
+ name : str
+ The atom name.
+
+ Returns
+ -------
+ tuple[int, int, int, int]
+ The converted atom name.
+
+ """
+ name = str(name).strip()
+ name = [ord(c) - 32 for c in name]
+ name = name + [0] * (4 - len(name))
+ return tuple(name)
+
+
+def sample_d(
+ min_d: float,
+ max_d: float,
+ n_samples: int,
+ random: np.random.Generator,
+) -> np.ndarray:
+ """Generate samples from a 1/d distribution between min_d and max_d.
+
+ Parameters
+ ----------
+ min_d : float
+ Minimum value of d
+ max_d : float
+ Maximum value of d
+ n_samples : int
+ Number of samples to generate
+ random : numpy.random.Generator
+ Random number generator
+
+ Returns
+ -------
+ numpy.ndarray
+ Array of samples drawn from the distribution
+
+ Notes
+ -----
+ The probability density function is:
+ f(d) = 1/(d * ln(max_d/min_d)) for d in [min_d, max_d]
+
+ The inverse CDF transform is:
+ d = min_d * (max_d/min_d)**u where u ~ Uniform(0,1)
+
+ """
+ # Generate n_samples uniform random numbers in [0, 1]
+ u = random.random(n_samples)
+ # Transform u using the inverse CDF
+ return min_d * (max_d / min_d) ** u
+
+
+def compute_frames_nonpolymer(
+ data: Tokenized,
+ coords,
+ resolved_mask,
+ atom_to_token,
+ frame_data: list,
+ resolved_frame_data: list,
+) -> tuple[list, list]:
+ """Get the frames for non-polymer tokens.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The input data to the model.
+ frame_data : list
+ The frame data.
+ resolved_frame_data : list
+ The resolved frame data.
+
+ Returns
+ -------
+ tuple[list, list]
+ The frame data and resolved frame data.
+
+ """
+ frame_data = np.array(frame_data)
+ resolved_frame_data = np.array(resolved_frame_data)
+ asym_id_token = data.tokens["asym_id"]
+ asym_id_atom = data.tokens["asym_id"][atom_to_token]
+ token_idx = 0
+ atom_idx = 0
+ for id in np.unique(data.tokens["asym_id"]):
+ mask_chain_token = asym_id_token == id
+ mask_chain_atom = asym_id_atom == id
+ num_tokens = mask_chain_token.sum()
+ num_atoms = mask_chain_atom.sum()
+ if (
+ data.tokens[token_idx]["mol_type"] != const.chain_type_ids["NONPOLYMER"]
+ or num_atoms < 3 # noqa: PLR2004
+ ):
+ token_idx += num_tokens
+ atom_idx += num_atoms
+ continue
+ dist_mat = (
+ (
+ coords.reshape(-1, 3)[mask_chain_atom][:, None, :]
+ - coords.reshape(-1, 3)[mask_chain_atom][None, :, :]
+ )
+ ** 2
+ ).sum(-1) ** 0.5
+ resolved_pair = 1 - (
+ resolved_mask[mask_chain_atom][None, :]
+ * resolved_mask[mask_chain_atom][:, None]
+ ).astype(np.float32)
+ resolved_pair[resolved_pair == 1] = math.inf
+ indices = np.argsort(dist_mat + resolved_pair, axis=1)
+ frames = (
+ np.concatenate(
+ [
+ indices[:, 1:2],
+ indices[:, 0:1],
+ indices[:, 2:3],
+ ],
+ axis=1,
+ )
+ + atom_idx
+ )
+ frame_data[token_idx : token_idx + num_atoms, :] = frames
+ resolved_frame_data[token_idx : token_idx + num_atoms] = resolved_mask[
+ frames
+ ].all(axis=1)
+ token_idx += num_tokens
+ atom_idx += num_atoms
+ frames_expanded = coords.reshape(-1, 3)[frame_data]
+
+ mask_collinear = compute_collinear_mask(
+ frames_expanded[:, 1] - frames_expanded[:, 0],
+ frames_expanded[:, 1] - frames_expanded[:, 2],
+ )
+ return frame_data, resolved_frame_data & mask_collinear
+
+
+def compute_collinear_mask(v1, v2):
+ norm1 = np.linalg.norm(v1, axis=1, keepdims=True)
+ norm2 = np.linalg.norm(v2, axis=1, keepdims=True)
+ v1 = v1 / (norm1 + 1e-6)
+ v2 = v2 / (norm2 + 1e-6)
+ mask_angle = np.abs(np.sum(v1 * v2, axis=1)) < 0.9063
+ mask_overlap1 = norm1.reshape(-1) > 1e-2
+ mask_overlap2 = norm2.reshape(-1) > 1e-2
+ return mask_angle & mask_overlap1 & mask_overlap2
+
+
+def dummy_msa(residues: np.ndarray) -> MSA:
+ """Create a dummy MSA for a chain.
+
+ Parameters
+ ----------
+ residues : np.ndarray
+ The residues for the chain.
+
+ Returns
+ -------
+ MSA
+ The dummy MSA.
+
+ """
+ residues = [res["res_type"] for res in residues]
+ deletions = []
+ sequences = [(0, -1, 0, len(residues), 0, 0)]
+ return MSA(
+ residues=np.array(residues, dtype=MSAResidue),
+ deletions=np.array(deletions, dtype=MSADeletion),
+ sequences=np.array(sequences, dtype=MSASequence),
+ )
+
+
+def construct_paired_msa( # noqa: C901, PLR0915, PLR0912
+ data: Tokenized,
+ random: np.random.Generator,
+ max_seqs: int,
+ max_pairs: int = 8192,
+ max_total: int = 16384,
+ random_subset: bool = False,
+) -> tuple[Tensor, Tensor, Tensor]:
+ """Pair the MSA data.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The input data to the model.
+
+ Returns
+ -------
+ Tensor
+ The MSA data.
+ Tensor
+ The deletion data.
+ Tensor
+ Mask indicating paired sequences.
+
+ """
+ # Get unique chains (ensuring monotonicity in the order)
+ assert np.all(np.diff(data.tokens["asym_id"], n=1) >= 0)
+ chain_ids = np.unique(data.tokens["asym_id"])
+
+ # Get relevant MSA, and create a dummy for chains without
+ msa: dict[int, MSA] = {}
+ for chain_id in chain_ids:
+ # Get input sequence
+ chain = data.structure.chains[chain_id]
+ res_start = chain["res_idx"]
+ res_end = res_start + chain["res_num"]
+ residues = data.structure.residues[res_start:res_end]
+
+ # Check if we have an MSA, and that the
+ # first sequence matches the input sequence
+ if chain_id in data.msa:
+ # Set the MSA
+ msa[chain_id] = data.msa[chain_id]
+
+ # Run length and residue type checks
+ first = data.msa[chain_id].sequences[0]
+ first_start = first["res_start"]
+ first_end = first["res_end"]
+ msa_residues = data.msa[chain_id].residues
+ first_residues = msa_residues[first_start:first_end]
+
+ warning = "Warning: MSA does not match input sequence, creating dummy."
+ if len(residues) == len(first_residues):
+ # If there is a mismatch, check if it is between MET & UNK
+ # If so, replace the first sequence with the input sequence.
+ # Otherwise, replace with a dummy MSA for this chain.
+ mismatches = residues["res_type"] != first_residues["res_type"]
+ if mismatches.sum().item():
+ idx = np.where(mismatches)[0]
+ is_met = residues["res_type"][idx] == const.token_ids["MET"]
+ is_unk = residues["res_type"][idx] == const.token_ids["UNK"]
+ is_msa_unk = (
+ first_residues["res_type"][idx] == const.token_ids["UNK"]
+ )
+ if (np.all(is_met) and np.all(is_msa_unk)) or np.all(is_unk):
+ msa_residues[first_start:first_end]["res_type"] = residues[
+ "res_type"
+ ]
+ else:
+ print(
+ warning,
+ "1",
+ residues["res_type"],
+ first_residues["res_type"],
+ data.record.id,
+ )
+ msa[chain_id] = dummy_msa(residues)
+ else:
+ print(
+ warning,
+ "2",
+ residues["res_type"],
+ first_residues["res_type"],
+ data.record.id,
+ )
+ msa[chain_id] = dummy_msa(residues)
+ else:
+ msa[chain_id] = dummy_msa(residues)
+
+ # Map taxonomies to (chain_id, seq_idx)
+ taxonomy_map: dict[str, list] = {}
+ for chain_id, chain_msa in msa.items():
+ sequences = chain_msa.sequences
+ sequences = sequences[sequences["taxonomy"] != -1]
+ for sequence in sequences:
+ seq_idx = sequence["seq_idx"]
+ taxon = sequence["taxonomy"]
+ taxonomy_map.setdefault(taxon, []).append((chain_id, seq_idx))
+
+ # Remove taxonomies with only one sequence and sort by the
+ # number of chain_id present in each of the taxonomies
+ taxonomy_map = {k: v for k, v in taxonomy_map.items() if len(v) > 1}
+ taxonomy_map = sorted(
+ taxonomy_map.items(),
+ key=lambda x: len({c for c, _ in x[1]}),
+ reverse=True,
+ )
+
+ # Keep track of the sequences available per chain, keeping the original
+ # order of the sequences in the MSA to favor the best matching sequences
+ visited = {(c, s) for c, items in taxonomy_map for s in items}
+ available = {}
+ for c in chain_ids:
+ available[c] = deque(
+ i for i in range(1, len(msa[c].sequences)) if (c, i) not in visited
+ )
+
+ # Create sequence pairs
+ is_paired = []
+ pairing = []
+
+ # Start with the first sequence for each chain
+ is_paired.append({c: 1 for c in chain_ids})
+ pairing.append({c: 0 for c in chain_ids})
+
+ # Then add up to 8191 paired rows
+ for _, pairs in taxonomy_map:
+ # Group occurences by chain_id in case we have multiple
+ # sequences from the same chain and same taxonomy
+ chain_occurences = {}
+ for chain_id, seq_idx in pairs:
+ chain_occurences.setdefault(chain_id, []).append(seq_idx)
+
+ # We create as many pairings as the maximum number of occurences
+ max_occurences = max(len(v) for v in chain_occurences.values())
+ for i in range(max_occurences):
+ row_pairing = {}
+ row_is_paired = {}
+
+ # Add the chains present in the taxonomy
+ for chain_id, seq_idxs in chain_occurences.items():
+ # Roll over the sequence index to maximize diversity
+ idx = i % len(seq_idxs)
+ seq_idx = seq_idxs[idx]
+
+ # Add the sequence to the pairing
+ row_pairing[chain_id] = seq_idx
+ row_is_paired[chain_id] = 1
+
+ # Add any missing chains
+ for chain_id in chain_ids:
+ if chain_id not in row_pairing:
+ row_is_paired[chain_id] = 0
+ if available[chain_id]:
+ # Add the next available sequence
+ row_pairing[chain_id] = available[chain_id].popleft()
+ else:
+ # No more sequences available, we place a gap
+ row_pairing[chain_id] = -1
+
+ pairing.append(row_pairing)
+ is_paired.append(row_is_paired)
+
+ # Break if we have enough pairs
+ if len(pairing) >= max_pairs:
+ break
+
+ # Break if we have enough pairs
+ if len(pairing) >= max_pairs:
+ break
+
+ # Now add up to 16384 unpaired rows total
+ max_left = max(len(v) for v in available.values())
+ for _ in range(min(max_total - len(pairing), max_left)):
+ row_pairing = {}
+ row_is_paired = {}
+ for chain_id in chain_ids:
+ row_is_paired[chain_id] = 0
+ if available[chain_id]:
+ # Add the next available sequence
+ row_pairing[chain_id] = available[chain_id].popleft()
+ else:
+ # No more sequences available, we place a gap
+ row_pairing[chain_id] = -1
+
+ pairing.append(row_pairing)
+ is_paired.append(row_is_paired)
+
+ # Break if we have enough sequences
+ if len(pairing) >= max_total:
+ break
+
+ # Randomly sample a subset of the pairs
+ # ensuring the first row is always present
+ if random_subset:
+ num_seqs = len(pairing)
+ if num_seqs > max_seqs:
+ indices = random.choice(
+ np.arange(1, num_seqs), size=max_seqs - 1, replace=False
+ ) # noqa: NPY002
+ pairing = [pairing[0]] + [pairing[i] for i in indices]
+ is_paired = [is_paired[0]] + [is_paired[i] for i in indices]
+ else:
+ # Deterministic downsample to max_seqs
+ pairing = pairing[:max_seqs]
+ is_paired = is_paired[:max_seqs]
+
+ # Map (chain_id, seq_idx, res_idx) to deletion
+ deletions = numba.typed.Dict.empty(
+ key_type=numba.types.Tuple(
+ [numba.types.int64, numba.types.int64, numba.types.int64]),
+ value_type=numba.types.int64
+ )
+ for chain_id, chain_msa in msa.items():
+ chain_deletions = chain_msa.deletions
+ for sequence in chain_msa.sequences:
+ seq_idx = sequence["seq_idx"]
+ del_start = sequence["del_start"]
+ del_end = sequence["del_end"]
+ chain_deletions = chain_deletions[del_start:del_end]
+ for deletion_data in chain_deletions:
+ res_idx = deletion_data["res_idx"]
+ deletion_values = deletion_data["deletion"]
+ deletions[(chain_id, seq_idx, res_idx)] = deletion_values
+
+ # Add all the token MSA data
+ msa_data, del_data, paired_data = prepare_msa_arrays(
+ data.tokens, pairing, is_paired, deletions, msa
+ )
+
+ msa_data = torch.tensor(msa_data, dtype=torch.long)
+ del_data = torch.tensor(del_data, dtype=torch.float)
+ paired_data = torch.tensor(paired_data, dtype=torch.float)
+
+ return msa_data, del_data, paired_data
+
+
+def prepare_msa_arrays(
+ tokens,
+ pairing: list[dict[int, int]],
+ is_paired: list[dict[int, int]],
+ deletions: dict[tuple[int, int, int], int],
+ msa: dict[int, MSA],
+) -> tuple[npt.NDArray[np.int64], npt.NDArray[np.int64], npt.NDArray[np.int64]]:
+ """Reshape data to play nicely with numba jit."""
+ token_asym_ids_arr = np.array([t["asym_id"] for t in tokens], dtype=np.int64)
+ token_res_idxs_arr = np.array([t["res_idx"] for t in tokens], dtype=np.int64)
+
+ chain_ids = sorted(msa.keys())
+
+ # chain_ids are not necessarily contiguous (e.g. they might be 0, 24, 25).
+ # This allows us to look up a chain_id by it's index in the chain_ids list.
+ chain_id_to_idx = {chain_id: i for i, chain_id in enumerate(chain_ids)}
+ token_asym_ids_idx_arr = np.array(
+ [chain_id_to_idx[asym_id] for asym_id in token_asym_ids_arr], dtype=np.int64
+ )
+
+ pairing_arr = np.zeros((len(pairing), len(chain_ids)), dtype=np.int64)
+ is_paired_arr = np.zeros((len(is_paired), len(chain_ids)), dtype=np.int64)
+
+ for i, row_pairing in enumerate(pairing):
+ for chain_id in chain_ids:
+ pairing_arr[i, chain_id_to_idx[chain_id]] = row_pairing[chain_id]
+
+ for i, row_is_paired in enumerate(is_paired):
+ for chain_id in chain_ids:
+ is_paired_arr[i, chain_id_to_idx[chain_id]] = row_is_paired[chain_id]
+
+ max_seq_len = max(len(msa[chain_id].sequences) for chain_id in chain_ids)
+
+ # we want res_start from sequences
+ msa_sequences = np.full((len(chain_ids), max_seq_len), -1, dtype=np.int64)
+ for chain_id in chain_ids:
+ for i, seq in enumerate(msa[chain_id].sequences):
+ msa_sequences[chain_id_to_idx[chain_id], i] = seq["res_start"]
+
+ max_residues_len = max(len(msa[chain_id].residues) for chain_id in chain_ids)
+ msa_residues = np.full((len(chain_ids), max_residues_len), -1, dtype=np.int64)
+ for chain_id in chain_ids:
+ residues = msa[chain_id].residues.astype(np.int64)
+ idxs = np.arange(len(residues))
+ chain_idx = chain_id_to_idx[chain_id]
+ msa_residues[chain_idx, idxs] = residues
+
+ return _prepare_msa_arrays_inner(
+ token_asym_ids_arr,
+ token_res_idxs_arr,
+ token_asym_ids_idx_arr,
+ pairing_arr,
+ is_paired_arr,
+ deletions,
+ msa_sequences,
+ msa_residues,
+ const.token_ids["-"],
+ )
+
+
+deletions_dict_type = types.DictType(types.UniTuple(types.int64, 3), types.int64)
+
+
+@numba.njit(
+ [
+ types.Tuple(
+ (
+ types.int64[:, ::1], # msa_data
+ types.int64[:, ::1], # del_data
+ types.int64[:, ::1], # paired_data
+ )
+ )(
+ types.int64[::1], # token_asym_ids
+ types.int64[::1], # token_res_idxs
+ types.int64[::1], # token_asym_ids_idx
+ types.int64[:, ::1], # pairing
+ types.int64[:, ::1], # is_paired
+ deletions_dict_type, # deletions
+ types.int64[:, ::1], # msa_sequences
+ types.int64[:, ::1], # msa_residues
+ types.int64, # gap_token
+ )
+ ],
+ cache=True,
+)
+def _prepare_msa_arrays_inner(
+ token_asym_ids: npt.NDArray[np.int64],
+ token_res_idxs: npt.NDArray[np.int64],
+ token_asym_ids_idx: npt.NDArray[np.int64],
+ pairing: npt.NDArray[np.int64],
+ is_paired: npt.NDArray[np.int64],
+ deletions: dict[tuple[int, int, int], int],
+ msa_sequences: npt.NDArray[np.int64],
+ msa_residues: npt.NDArray[np.int64],
+ gap_token: int,
+) -> tuple[npt.NDArray[np.int64], npt.NDArray[np.int64], npt.NDArray[np.int64]]:
+ n_tokens = len(token_asym_ids)
+ n_pairs = len(pairing)
+ msa_data = np.full((n_tokens, n_pairs), gap_token, dtype=np.int64)
+ paired_data = np.zeros((n_tokens, n_pairs), dtype=np.int64)
+ del_data = np.zeros((n_tokens, n_pairs), dtype=np.int64)
+
+ # Add all the token MSA data
+ for token_idx in range(n_tokens):
+ chain_id_idx = token_asym_ids_idx[token_idx]
+ chain_id = token_asym_ids[token_idx]
+ res_idx = token_res_idxs[token_idx]
+
+ for pair_idx in range(n_pairs):
+ seq_idx = pairing[pair_idx, chain_id_idx]
+ paired_data[token_idx, pair_idx] = is_paired[pair_idx, chain_id_idx]
+
+ # Add residue type
+ if seq_idx != -1:
+ res_start = msa_sequences[chain_id_idx, seq_idx]
+ res_type = msa_residues[chain_id_idx, res_start + res_idx]
+ k = (chain_id, seq_idx, res_idx)
+ if k in deletions:
+ del_data[token_idx, pair_idx] = deletions[k]
+ msa_data[token_idx, pair_idx] = res_type
+
+ return msa_data, del_data, paired_data
+
+
+####################################################################################################
+# FEATURES
+####################################################################################################
+
+
+def select_subset_from_mask(mask, p, random: np.random.Generator) -> np.ndarray:
+ num_true = np.sum(mask)
+ v = random.geometric(p) + 1
+ k = min(v, num_true)
+
+ true_indices = np.where(mask)[0]
+
+ # Randomly select k indices from the true_indices
+ selected_indices = random.choice(true_indices, size=k, replace=False)
+
+ new_mask = np.zeros_like(mask)
+ new_mask[selected_indices] = 1
+
+ return new_mask
+
+
+def get_range_bin(value: float, range_dict: dict[tuple[float, float], int], default=0):
+ """Get the bin of a value given a range dictionary."""
+ value = float(value)
+ for k, idx in range_dict.items():
+ if k == "other":
+ continue
+ low, high = k
+ if low <= value < high:
+ return idx
+ return default
+
+
+def process_token_features( # noqa: C901, PLR0915, PLR0912
+ data: Tokenized,
+ random: np.random.Generator,
+ max_tokens: Optional[int] = None,
+ binder_pocket_conditioned_prop: Optional[float] = 0.0,
+ contact_conditioned_prop: Optional[float] = 0.0,
+ binder_pocket_cutoff_min: Optional[float] = 4.0,
+ binder_pocket_cutoff_max: Optional[float] = 20.0,
+ binder_pocket_sampling_geometric_p: Optional[float] = 0.0,
+ only_ligand_binder_pocket: Optional[bool] = False,
+ only_pp_contact: Optional[bool] = False,
+ inference_pocket_constraints: Optional[
+ list[tuple[int, list[tuple[int, int]], float]]
+ ] = False,
+ inference_contact_constraints: Optional[
+ list[tuple[tuple[int, int], tuple[int, int], float]]
+ ] = False,
+ override_method: Optional[str] = None,
+) -> dict[str, Tensor]:
+ """Get the token features.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The input data to the model.
+ max_tokens : int
+ The maximum number of tokens.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The token features.
+
+ """
+ # Token data
+ token_data = data.tokens
+ token_bonds = data.bonds
+
+ # Token core features
+ token_index = torch.arange(len(token_data), dtype=torch.long)
+ residue_index = from_numpy(token_data["res_idx"]).long()
+ asym_id = from_numpy(token_data["asym_id"]).long()
+ entity_id = from_numpy(token_data["entity_id"]).long()
+ sym_id = from_numpy(token_data["sym_id"]).long()
+ mol_type = from_numpy(token_data["mol_type"]).long()
+ res_type = from_numpy(token_data["res_type"]).long()
+ res_type = one_hot(res_type, num_classes=const.num_tokens)
+ disto_center = from_numpy(token_data["disto_coords"])
+ modified = from_numpy(token_data["modified"]).long() # float()
+ cyclic_period = from_numpy(token_data["cyclic_period"].copy())
+ affinity_mask = from_numpy(token_data["affinity_mask"]).float()
+
+ ## Conditioning features ##
+ method = (
+ np.zeros(len(token_data))
+ + const.method_types_ids[
+ (
+ "x-ray diffraction"
+ if override_method is None
+ else override_method.lower()
+ )
+ ]
+ )
+ if data.record is not None:
+ if (
+ override_method is None
+ and data.record.structure.method is not None
+ and data.record.structure.method.lower() in const.method_types_ids
+ ):
+ method = (method * 0) + const.method_types_ids[
+ data.record.structure.method.lower()
+ ]
+
+ method_feature = from_numpy(method).long()
+
+ # Token mask features
+ pad_mask = torch.ones(len(token_data), dtype=torch.float)
+ resolved_mask = from_numpy(token_data["resolved_mask"]).float()
+ disto_mask = from_numpy(token_data["disto_mask"]).float()
+
+ # Token bond features
+ if max_tokens is not None:
+ pad_len = max_tokens - len(token_data)
+ num_tokens = max_tokens if pad_len > 0 else len(token_data)
+ else:
+ num_tokens = len(token_data)
+
+ tok_to_idx = {tok["token_idx"]: idx for idx, tok in enumerate(token_data)}
+ bonds = torch.zeros(num_tokens, num_tokens, dtype=torch.float)
+ bonds_type = torch.zeros(num_tokens, num_tokens, dtype=torch.long)
+ for token_bond in token_bonds:
+ token_1 = tok_to_idx[token_bond["token_1"]]
+ token_2 = tok_to_idx[token_bond["token_2"]]
+ bonds[token_1, token_2] = 1
+ bonds[token_2, token_1] = 1
+ bond_type = token_bond["type"]
+ bonds_type[token_1, token_2] = bond_type
+ bonds_type[token_2, token_1] = bond_type
+
+ bonds = bonds.unsqueeze(-1)
+
+ # Pocket conditioned feature
+ contact_conditioning = (
+ np.zeros((len(token_data), len(token_data)))
+ + const.contact_conditioning_info["UNSELECTED"]
+ )
+ contact_threshold = np.zeros((len(token_data), len(token_data)))
+
+ if inference_pocket_constraints is not None:
+ for binder, contacts, max_distance, force in inference_pocket_constraints:
+ binder_mask = token_data["asym_id"] == binder
+
+ for idx, token in enumerate(token_data):
+ if (
+ token["mol_type"] != const.chain_type_ids["NONPOLYMER"]
+ and (token["asym_id"], token["res_idx"]) in contacts
+ ) or (
+ token["mol_type"] == const.chain_type_ids["NONPOLYMER"]
+ and (token["asym_id"], token["atom_idx"]) in contacts
+ ):
+ contact_conditioning[binder_mask, idx] = (
+ const.contact_conditioning_info["BINDER>POCKET"]
+ )
+ contact_conditioning[idx, binder_mask] = (
+ const.contact_conditioning_info["POCKET>BINDER"]
+ )
+ contact_threshold[binder_mask, idx] = max_distance
+ contact_threshold[idx, binder_mask] = max_distance
+
+ if inference_contact_constraints is not None:
+ for token1, token2, max_distance, force in inference_contact_constraints:
+ for idx1, _token1 in enumerate(token_data):
+ if (
+ _token1["mol_type"] != const.chain_type_ids["NONPOLYMER"]
+ and (_token1["asym_id"], _token1["res_idx"]) == token1
+ ) or (
+ _token1["mol_type"] == const.chain_type_ids["NONPOLYMER"]
+ and (_token1["asym_id"], _token1["atom_idx"]) == token1
+ ):
+ for idx2, _token2 in enumerate(token_data):
+ if (
+ _token2["mol_type"] != const.chain_type_ids["NONPOLYMER"]
+ and (_token2["asym_id"], _token2["res_idx"]) == token2
+ ) or (
+ _token2["mol_type"] == const.chain_type_ids["NONPOLYMER"]
+ and (_token2["asym_id"], _token2["atom_idx"]) == token2
+ ):
+ contact_conditioning[idx1, idx2] = (
+ const.contact_conditioning_info["CONTACT"]
+ )
+ contact_conditioning[idx2, idx1] = (
+ const.contact_conditioning_info["CONTACT"]
+ )
+ contact_threshold[idx1, idx2] = max_distance
+ contact_threshold[idx2, idx1] = max_distance
+ break
+ break
+
+ if binder_pocket_conditioned_prop > 0.0:
+ # choose as binder a random ligand in the crop, if there are no ligands select a protein chain
+ binder_asym_ids = np.unique(
+ token_data["asym_id"][
+ token_data["mol_type"] == const.chain_type_ids["NONPOLYMER"]
+ ]
+ )
+
+ if len(binder_asym_ids) == 0:
+ if not only_ligand_binder_pocket:
+ binder_asym_ids = np.unique(token_data["asym_id"])
+
+ while random.random() < binder_pocket_conditioned_prop:
+ if len(binder_asym_ids) == 0:
+ break
+
+ pocket_asym_id = random.choice(binder_asym_ids)
+ binder_asym_ids = binder_asym_ids[binder_asym_ids != pocket_asym_id]
+
+ binder_pocket_cutoff = sample_d(
+ min_d=binder_pocket_cutoff_min,
+ max_d=binder_pocket_cutoff_max,
+ n_samples=1,
+ random=random,
+ )
+
+ binder_mask = token_data["asym_id"] == pocket_asym_id
+
+ binder_coords = []
+ for token in token_data:
+ if token["asym_id"] == pocket_asym_id:
+ _coords = data.structure.atoms["coords"][
+ token["atom_idx"] : token["atom_idx"] + token["atom_num"]
+ ]
+ _is_present = data.structure.atoms["is_present"][
+ token["atom_idx"] : token["atom_idx"] + token["atom_num"]
+ ]
+ binder_coords.append(_coords[_is_present])
+ binder_coords = np.concatenate(binder_coords, axis=0)
+
+ # find the tokens in the pocket
+ token_dist = np.zeros(len(token_data)) + 1000
+ for i, token in enumerate(token_data):
+ if (
+ token["mol_type"] != const.chain_type_ids["NONPOLYMER"]
+ and token["asym_id"] != pocket_asym_id
+ and token["resolved_mask"] == 1
+ ):
+ token_coords = data.structure.atoms["coords"][
+ token["atom_idx"] : token["atom_idx"] + token["atom_num"]
+ ]
+ token_is_present = data.structure.atoms["is_present"][
+ token["atom_idx"] : token["atom_idx"] + token["atom_num"]
+ ]
+ token_coords = token_coords[token_is_present]
+
+ # find chain and apply chain transformation
+ for chain in data.structure.chains:
+ if chain["asym_id"] == token["asym_id"]:
+ break
+
+ token_dist[i] = np.min(
+ np.linalg.norm(
+ token_coords[:, None, :] - binder_coords[None, :, :],
+ axis=-1,
+ )
+ )
+
+ pocket_mask = token_dist < binder_pocket_cutoff
+
+ if np.sum(pocket_mask) > 0:
+ if binder_pocket_sampling_geometric_p > 0.0:
+ # select a subset of the pocket, according
+ # to a geometric distribution with one as minimum
+ pocket_mask = select_subset_from_mask(
+ pocket_mask,
+ binder_pocket_sampling_geometric_p,
+ random,
+ )
+
+ contact_conditioning[np.ix_(binder_mask, pocket_mask)] = (
+ const.contact_conditioning_info["BINDER>POCKET"]
+ )
+ contact_conditioning[np.ix_(pocket_mask, binder_mask)] = (
+ const.contact_conditioning_info["POCKET>BINDER"]
+ )
+ contact_threshold[np.ix_(binder_mask, pocket_mask)] = (
+ binder_pocket_cutoff
+ )
+ contact_threshold[np.ix_(pocket_mask, binder_mask)] = (
+ binder_pocket_cutoff
+ )
+
+ # Contact conditioning feature
+ if contact_conditioned_prop > 0.0:
+ while random.random() < contact_conditioned_prop:
+ contact_cutoff = sample_d(
+ min_d=binder_pocket_cutoff_min,
+ max_d=binder_pocket_cutoff_max,
+ n_samples=1,
+ random=random,
+ )
+ if only_pp_contact:
+ chain_asym_ids = np.unique(
+ token_data["asym_id"][
+ token_data["mol_type"] == const.chain_type_ids["PROTEIN"]
+ ]
+ )
+ else:
+ chain_asym_ids = np.unique(token_data["asym_id"])
+
+ if len(chain_asym_ids) > 1:
+ chain_asym_id = random.choice(chain_asym_ids)
+
+ chain_coords = []
+ for token in token_data:
+ if token["asym_id"] == chain_asym_id:
+ _coords = data.structure.atoms["coords"][
+ token["atom_idx"] : token["atom_idx"] + token["atom_num"]
+ ]
+ _is_present = data.structure.atoms["is_present"][
+ token["atom_idx"] : token["atom_idx"] + token["atom_num"]
+ ]
+ chain_coords.append(_coords[_is_present])
+ chain_coords = np.concatenate(chain_coords, axis=0)
+
+ # find contacts in other chains
+ possible_other_chains = []
+ for other_chain_id in chain_asym_ids[chain_asym_ids != chain_asym_id]:
+ for token in token_data:
+ if token["asym_id"] == other_chain_id:
+ _coords = data.structure.atoms["coords"][
+ token["atom_idx"] : token["atom_idx"]
+ + token["atom_num"]
+ ]
+ _is_present = data.structure.atoms["is_present"][
+ token["atom_idx"] : token["atom_idx"]
+ + token["atom_num"]
+ ]
+ if _is_present.sum() == 0:
+ continue
+ token_coords = _coords[_is_present]
+
+ # check minimum distance
+ if (
+ np.min(cdist(chain_coords, token_coords))
+ < contact_cutoff
+ ):
+ possible_other_chains.append(other_chain_id)
+ break
+
+ if len(possible_other_chains) > 0:
+ other_chain_id = random.choice(possible_other_chains)
+
+ pairs = []
+ for token_1 in token_data:
+ if token_1["asym_id"] == chain_asym_id:
+ _coords = data.structure.atoms["coords"][
+ token_1["atom_idx"] : token_1["atom_idx"]
+ + token_1["atom_num"]
+ ]
+ _is_present = data.structure.atoms["is_present"][
+ token_1["atom_idx"] : token_1["atom_idx"]
+ + token_1["atom_num"]
+ ]
+ if _is_present.sum() == 0:
+ continue
+ token_1_coords = _coords[_is_present]
+
+ for token_2 in token_data:
+ if token_2["asym_id"] == other_chain_id:
+ _coords = data.structure.atoms["coords"][
+ token_2["atom_idx"] : token_2["atom_idx"]
+ + token_2["atom_num"]
+ ]
+ _is_present = data.structure.atoms["is_present"][
+ token_2["atom_idx"] : token_2["atom_idx"]
+ + token_2["atom_num"]
+ ]
+ if _is_present.sum() == 0:
+ continue
+ token_2_coords = _coords[_is_present]
+
+ if (
+ np.min(cdist(token_1_coords, token_2_coords))
+ < contact_cutoff
+ ):
+ pairs.append(
+ (token_1["token_idx"], token_2["token_idx"])
+ )
+
+ assert len(pairs) > 0
+
+ pair = random.choice(pairs)
+ token_1_mask = token_data["token_idx"] == pair[0]
+ token_2_mask = token_data["token_idx"] == pair[1]
+
+ contact_conditioning[np.ix_(token_1_mask, token_2_mask)] = (
+ const.contact_conditioning_info["CONTACT"]
+ )
+ contact_conditioning[np.ix_(token_2_mask, token_1_mask)] = (
+ const.contact_conditioning_info["CONTACT"]
+ )
+
+ elif not only_pp_contact:
+ # only one chain, find contacts within the chain with minimum residue distance
+ pairs = []
+ for token_1 in token_data:
+ _coords = data.structure.atoms["coords"][
+ token_1["atom_idx"] : token_1["atom_idx"] + token_1["atom_num"]
+ ]
+ _is_present = data.structure.atoms["is_present"][
+ token_1["atom_idx"] : token_1["atom_idx"] + token_1["atom_num"]
+ ]
+ if _is_present.sum() == 0:
+ continue
+ token_1_coords = _coords[_is_present]
+
+ for token_2 in token_data:
+ if np.abs(token_1["res_idx"] - token_2["res_idx"]) <= 8:
+ continue
+
+ _coords = data.structure.atoms["coords"][
+ token_2["atom_idx"] : token_2["atom_idx"]
+ + token_2["atom_num"]
+ ]
+ _is_present = data.structure.atoms["is_present"][
+ token_2["atom_idx"] : token_2["atom_idx"]
+ + token_2["atom_num"]
+ ]
+ if _is_present.sum() == 0:
+ continue
+ token_2_coords = _coords[_is_present]
+
+ if (
+ np.min(cdist(token_1_coords, token_2_coords))
+ < contact_cutoff
+ ):
+ pairs.append((token_1["token_idx"], token_2["token_idx"]))
+
+ if len(pairs) > 0:
+ pair = random.choice(pairs)
+ token_1_mask = token_data["token_idx"] == pair[0]
+ token_2_mask = token_data["token_idx"] == pair[1]
+
+ contact_conditioning[np.ix_(token_1_mask, token_2_mask)] = (
+ const.contact_conditioning_info["CONTACT"]
+ )
+ contact_conditioning[np.ix_(token_2_mask, token_1_mask)] = (
+ const.contact_conditioning_info["CONTACT"]
+ )
+
+ if np.all(contact_conditioning == const.contact_conditioning_info["UNSELECTED"]):
+ contact_conditioning = (
+ contact_conditioning
+ - const.contact_conditioning_info["UNSELECTED"]
+ + const.contact_conditioning_info["UNSPECIFIED"]
+ )
+ contact_conditioning = from_numpy(contact_conditioning).long()
+ contact_conditioning = one_hot(
+ contact_conditioning, num_classes=len(const.contact_conditioning_info)
+ )
+ contact_threshold = from_numpy(contact_threshold).float()
+
+ # compute cyclic polymer mask
+ cyclic_ids = {}
+ for idx_chain, asym_id_iter in enumerate(data.structure.chains["asym_id"]):
+ for connection in data.structure.bonds:
+ if (
+ idx_chain == connection["chain_1"] == connection["chain_2"]
+ and data.structure.chains[connection["chain_1"]]["res_num"] > 2
+ and connection["res_1"]
+ != connection["res_2"] # Avoid same residue bonds!
+ ):
+ if (
+ data.structure.chains[connection["chain_1"]]["res_num"]
+ == (connection["res_2"] + 1)
+ and connection["res_1"] == 0
+ ) or (
+ data.structure.chains[connection["chain_1"]]["res_num"]
+ == (connection["res_1"] + 1)
+ and connection["res_2"] == 0
+ ):
+ cyclic_ids[asym_id_iter] = data.structure.chains[
+ connection["chain_1"]
+ ]["res_num"]
+ cyclic = from_numpy(
+ np.array(
+ [
+ (cyclic_ids[asym_id_iter] if asym_id_iter in cyclic_ids else 0)
+ for asym_id_iter in token_data["asym_id"]
+ ]
+ )
+ ).float()
+
+ # cyclic period is either computed from the bonds or given as input flag
+ cyclic_period = torch.maximum(cyclic, cyclic_period)
+
+ # Pad to max tokens if given
+ if max_tokens is not None:
+ pad_len = max_tokens - len(token_data)
+ if pad_len > 0:
+ token_index = pad_dim(token_index, 0, pad_len)
+ residue_index = pad_dim(residue_index, 0, pad_len)
+ asym_id = pad_dim(asym_id, 0, pad_len)
+ entity_id = pad_dim(entity_id, 0, pad_len)
+ sym_id = pad_dim(sym_id, 0, pad_len)
+ mol_type = pad_dim(mol_type, 0, pad_len)
+ res_type = pad_dim(res_type, 0, pad_len)
+ disto_center = pad_dim(disto_center, 0, pad_len)
+ pad_mask = pad_dim(pad_mask, 0, pad_len)
+ resolved_mask = pad_dim(resolved_mask, 0, pad_len)
+ disto_mask = pad_dim(disto_mask, 0, pad_len)
+ contact_conditioning = pad_dim(contact_conditioning, 0, pad_len)
+ contact_conditioning = pad_dim(contact_conditioning, 1, pad_len)
+ contact_threshold = pad_dim(contact_threshold, 0, pad_len)
+ contact_threshold = pad_dim(contact_threshold, 1, pad_len)
+ method_feature = pad_dim(method_feature, 0, pad_len)
+ modified = pad_dim(modified, 0, pad_len)
+ cyclic_period = pad_dim(cyclic_period, 0, pad_len)
+ affinity_mask = pad_dim(affinity_mask, 0, pad_len)
+
+ token_features = {
+ "token_index": token_index,
+ "residue_index": residue_index,
+ "asym_id": asym_id,
+ "entity_id": entity_id,
+ "sym_id": sym_id,
+ "mol_type": mol_type,
+ "res_type": res_type,
+ "disto_center": disto_center,
+ "token_bonds": bonds,
+ "type_bonds": bonds_type,
+ "token_pad_mask": pad_mask,
+ "token_resolved_mask": resolved_mask,
+ "token_disto_mask": disto_mask,
+ "contact_conditioning": contact_conditioning,
+ "contact_threshold": contact_threshold,
+ "method_feature": method_feature,
+ "modified": modified,
+ "cyclic_period": cyclic_period,
+ "affinity_token_mask": affinity_mask,
+ }
+
+ return token_features
+
+
+def process_atom_features(
+ data: Tokenized,
+ random: np.random.Generator,
+ ensemble_features: dict,
+ molecules: dict[str, Mol],
+ atoms_per_window_queries: int = 32,
+ min_dist: float = 2.0,
+ max_dist: float = 22.0,
+ num_bins: int = 64,
+ max_atoms: Optional[int] = None,
+ max_tokens: Optional[int] = None,
+ disto_use_ensemble: Optional[bool] = False,
+ override_bfactor: bool = False,
+ compute_frames: bool = False,
+ override_coords: Optional[Tensor] = None,
+ bfactor_md_correction: bool = False,
+) -> dict[str, Tensor]:
+ """Get the atom features.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The input to the model.
+ max_atoms : int, optional
+ The maximum number of atoms.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The atom features.
+
+ """
+ # Filter to tokens' atoms
+ atom_data = []
+ atom_name = []
+ atom_element = []
+ atom_charge = []
+ atom_conformer = []
+ atom_chirality = []
+ ref_space_uid = []
+ coord_data = []
+ if compute_frames:
+ frame_data = []
+ resolved_frame_data = []
+ atom_to_token = []
+ token_to_rep_atom = [] # index on cropped atom table
+ r_set_to_rep_atom = []
+ disto_coords_ensemble = []
+ backbone_feat_index = []
+ token_to_center_atom = []
+
+ e_offsets = data.structure.ensemble["atom_coord_idx"]
+ atom_idx = 0
+
+ # Start atom idx in full atom table for structures chosen. Up to num_ensembles points.
+ ensemble_atom_starts = [
+ data.structure.ensemble[idx]["atom_coord_idx"]
+ for idx in ensemble_features["ensemble_ref_idxs"]
+ ]
+
+ # Set unk chirality id
+ unk_chirality = const.chirality_type_ids[const.unk_chirality_type]
+
+ chain_res_ids = {}
+ res_index_to_conf_id = {}
+ for token_id, token in enumerate(data.tokens):
+ # Get the chain residue ids
+ chain_idx, res_id = token["asym_id"], token["res_idx"]
+ chain = data.structure.chains[chain_idx]
+
+ if (chain_idx, res_id) not in chain_res_ids:
+ new_idx = len(chain_res_ids)
+ chain_res_ids[(chain_idx, res_id)] = new_idx
+ else:
+ new_idx = chain_res_ids[(chain_idx, res_id)]
+
+ # Get the molecule and conformer
+ mol = molecules[token["res_name"]]
+ atom_name_to_ref = {a.GetProp("name"): a for a in mol.GetAtoms()}
+
+ # Sample a random conformer
+ if (chain_idx, res_id) not in res_index_to_conf_id:
+ conf_ids = [int(conf.GetId()) for conf in mol.GetConformers()]
+ conf_id = int(random.choice(conf_ids))
+ res_index_to_conf_id[(chain_idx, res_id)] = conf_id
+
+ conf_id = res_index_to_conf_id[(chain_idx, res_id)]
+ conformer = mol.GetConformer(conf_id)
+
+ # Map atoms to token indices
+ ref_space_uid.extend([new_idx] * token["atom_num"])
+ atom_to_token.extend([token_id] * token["atom_num"])
+
+ # Add atom data
+ start = token["atom_idx"]
+ end = token["atom_idx"] + token["atom_num"]
+ token_atoms = data.structure.atoms[start:end]
+
+ # Add atom ref data
+ # element, charge, conformer, chirality
+ token_atom_name = np.array([convert_atom_name(a["name"]) for a in token_atoms])
+ token_atoms_ref = np.array([atom_name_to_ref[a["name"]] for a in token_atoms])
+ token_atoms_element = np.array([a.GetAtomicNum() for a in token_atoms_ref])
+ token_atoms_charge = np.array([a.GetFormalCharge() for a in token_atoms_ref])
+ token_atoms_conformer = np.array(
+ [
+ (
+ conformer.GetAtomPosition(a.GetIdx()).x,
+ conformer.GetAtomPosition(a.GetIdx()).y,
+ conformer.GetAtomPosition(a.GetIdx()).z,
+ )
+ for a in token_atoms_ref
+ ]
+ )
+ token_atoms_chirality = np.array(
+ [
+ const.chirality_type_ids.get(a.GetChiralTag().name, unk_chirality)
+ for a in token_atoms_ref
+ ]
+ )
+
+ # Map token to representative atom
+ token_to_rep_atom.append(atom_idx + token["disto_idx"] - start)
+ token_to_center_atom.append(atom_idx + token["center_idx"] - start)
+ if (chain["mol_type"] != const.chain_type_ids["NONPOLYMER"]) and token[
+ "resolved_mask"
+ ]:
+ r_set_to_rep_atom.append(atom_idx + token["center_idx"] - start)
+
+ if chain["mol_type"] == const.chain_type_ids["PROTEIN"]:
+ backbone_index = [
+ (
+ const.protein_backbone_atom_index[atom_name] + 1
+ if atom_name in const.protein_backbone_atom_index
+ else 0
+ )
+ for atom_name in token_atoms["name"]
+ ]
+ elif (
+ chain["mol_type"] == const.chain_type_ids["DNA"]
+ or chain["mol_type"] == const.chain_type_ids["RNA"]
+ ):
+ backbone_index = [
+ (
+ const.nucleic_backbone_atom_index[atom_name]
+ + 1
+ + len(const.protein_backbone_atom_index)
+ if atom_name in const.nucleic_backbone_atom_index
+ else 0
+ )
+ for atom_name in token_atoms["name"]
+ ]
+ else:
+ backbone_index = [0] * token["atom_num"]
+ backbone_feat_index.extend(backbone_index)
+
+ # Get token coordinates across sampled ensembles and apply transforms
+ token_coords = np.array(
+ [
+ data.structure.coords[
+ ensemble_atom_start + start : ensemble_atom_start + end
+ ]["coords"]
+ for ensemble_atom_start in ensemble_atom_starts
+ ]
+ )
+ coord_data.append(token_coords)
+
+ if compute_frames:
+ # Get frame data
+ res_type = const.tokens[token["res_type"]]
+ res_name = str(token["res_name"])
+
+ if token["atom_num"] < 3 or res_type in ["PAD", "UNK", "-"]:
+ idx_frame_a, idx_frame_b, idx_frame_c = 0, 0, 0
+ mask_frame = False
+ elif (token["mol_type"] == const.chain_type_ids["PROTEIN"]) and (
+ res_name in const.ref_atoms
+ ):
+ idx_frame_a, idx_frame_b, idx_frame_c = (
+ const.ref_atoms[res_name].index("N"),
+ const.ref_atoms[res_name].index("CA"),
+ const.ref_atoms[res_name].index("C"),
+ )
+ mask_frame = (
+ token_atoms["is_present"][idx_frame_a]
+ and token_atoms["is_present"][idx_frame_b]
+ and token_atoms["is_present"][idx_frame_c]
+ )
+ elif (
+ token["mol_type"] == const.chain_type_ids["DNA"]
+ or token["mol_type"] == const.chain_type_ids["RNA"]
+ ) and (res_name in const.ref_atoms):
+ idx_frame_a, idx_frame_b, idx_frame_c = (
+ const.ref_atoms[res_name].index("C1'"),
+ const.ref_atoms[res_name].index("C3'"),
+ const.ref_atoms[res_name].index("C4'"),
+ )
+ mask_frame = (
+ token_atoms["is_present"][idx_frame_a]
+ and token_atoms["is_present"][idx_frame_b]
+ and token_atoms["is_present"][idx_frame_c]
+ )
+ elif token["mol_type"] == const.chain_type_ids["PROTEIN"]:
+ # Try to look for the atom nams in the modified residue
+ is_ca = token_atoms["name"] == "CA"
+ idx_frame_a = is_ca.argmax()
+ ca_present = (
+ token_atoms[idx_frame_a]["is_present"] if is_ca.any() else False
+ )
+
+ is_n = token_atoms["name"] == "N"
+ idx_frame_b = is_n.argmax()
+ n_present = (
+ token_atoms[idx_frame_b]["is_present"] if is_n.any() else False
+ )
+
+ is_c = token_atoms["name"] == "C"
+ idx_frame_c = is_c.argmax()
+ c_present = (
+ token_atoms[idx_frame_c]["is_present"] if is_c.any() else False
+ )
+ mask_frame = ca_present and n_present and c_present
+
+ elif (token["mol_type"] == const.chain_type_ids["DNA"]) or (
+ token["mol_type"] == const.chain_type_ids["RNA"]
+ ):
+ # Try to look for the atom nams in the modified residue
+ is_c1 = token_atoms["name"] == "C1'"
+ idx_frame_a = is_c1.argmax()
+ c1_present = (
+ token_atoms[idx_frame_a]["is_present"] if is_c1.any() else False
+ )
+
+ is_c3 = token_atoms["name"] == "C3'"
+ idx_frame_b = is_c3.argmax()
+ c3_present = (
+ token_atoms[idx_frame_b]["is_present"] if is_c3.any() else False
+ )
+
+ is_c4 = token_atoms["name"] == "C4'"
+ idx_frame_c = is_c4.argmax()
+ c4_present = (
+ token_atoms[idx_frame_c]["is_present"] if is_c4.any() else False
+ )
+ mask_frame = c1_present and c3_present and c4_present
+ else:
+ idx_frame_a, idx_frame_b, idx_frame_c = 0, 0, 0
+ mask_frame = False
+ frame_data.append(
+ [
+ idx_frame_a + atom_idx,
+ idx_frame_b + atom_idx,
+ idx_frame_c + atom_idx,
+ ]
+ )
+ resolved_frame_data.append(mask_frame)
+
+ # Get distogram coordinates
+ disto_coords_ensemble_tok = data.structure.coords[
+ e_offsets + token["disto_idx"]
+ ]["coords"]
+ disto_coords_ensemble.append(disto_coords_ensemble_tok)
+
+ # Update atom data. This is technically never used again (we rely on coord_data),
+ # but we update for consistency and to make sure the Atom object has valid, transformed coordinates.
+ token_atoms = token_atoms.copy()
+ token_atoms["coords"] = token_coords[
+ 0
+ ] # atom has a copy of first coords in ensemble
+ atom_data.append(token_atoms)
+ atom_name.append(token_atom_name)
+ atom_element.append(token_atoms_element)
+ atom_charge.append(token_atoms_charge)
+ atom_conformer.append(token_atoms_conformer)
+ atom_chirality.append(token_atoms_chirality)
+ atom_idx += len(token_atoms)
+
+ disto_coords_ensemble = np.array(disto_coords_ensemble) # (N_TOK, N_ENS, 3)
+
+ # Compute ensemble distogram
+ L = len(data.tokens)
+
+ if disto_use_ensemble:
+ # Use all available structures to create distogram
+ idx_list = range(disto_coords_ensemble.shape[1])
+ else:
+ # Only use a sampled structures to create distogram
+ idx_list = ensemble_features["ensemble_ref_idxs"]
+
+ # Create distogram
+ disto_target = torch.zeros(L, L, len(idx_list), num_bins) # TODO1
+
+ # disto_target = torch.zeros(L, L, num_bins)
+ for i, e_idx in enumerate(idx_list):
+ t_center = torch.Tensor(disto_coords_ensemble[:, e_idx, :])
+ t_dists = torch.cdist(t_center, t_center)
+ boundaries = torch.linspace(min_dist, max_dist, num_bins - 1)
+ distogram = (t_dists.unsqueeze(-1) > boundaries).sum(dim=-1).long()
+ # disto_target += one_hot(distogram, num_classes=num_bins)
+ disto_target[:, :, i, :] = one_hot(distogram, num_classes=num_bins) # TODO1
+
+ # Normalize distogram
+ # disto_target = disto_target / disto_target.sum(-1)[..., None] # remove TODO1
+ atom_data = np.concatenate(atom_data)
+ atom_name = np.concatenate(atom_name)
+ atom_element = np.concatenate(atom_element)
+ atom_charge = np.concatenate(atom_charge)
+ atom_conformer = np.concatenate(atom_conformer)
+ atom_chirality = np.concatenate(atom_chirality)
+ coord_data = np.concatenate(coord_data, axis=1)
+ ref_space_uid = np.array(ref_space_uid)
+
+ # Compute features
+ disto_coords_ensemble = from_numpy(disto_coords_ensemble)
+ disto_coords_ensemble = disto_coords_ensemble[
+ :, ensemble_features["ensemble_ref_idxs"]
+ ].permute(1, 0, 2)
+ backbone_feat_index = from_numpy(np.asarray(backbone_feat_index)).long()
+ ref_atom_name_chars = from_numpy(atom_name).long()
+ ref_element = from_numpy(atom_element).long()
+ ref_charge = from_numpy(atom_charge).float()
+ ref_pos = from_numpy(atom_conformer).float()
+ ref_space_uid = from_numpy(ref_space_uid)
+ ref_chirality = from_numpy(atom_chirality).long()
+ coords = from_numpy(coord_data.copy())
+ resolved_mask = from_numpy(atom_data["is_present"])
+ pad_mask = torch.ones(len(atom_data), dtype=torch.float)
+ atom_to_token = torch.tensor(atom_to_token, dtype=torch.long)
+ token_to_rep_atom = torch.tensor(token_to_rep_atom, dtype=torch.long)
+ r_set_to_rep_atom = torch.tensor(r_set_to_rep_atom, dtype=torch.long)
+ token_to_center_atom = torch.tensor(token_to_center_atom, dtype=torch.long)
+ bfactor = from_numpy(atom_data["bfactor"].copy())
+ plddt = from_numpy(atom_data["plddt"].copy())
+ if override_bfactor:
+ bfactor = bfactor * 0.0
+
+ if bfactor_md_correction and data.record.structure.method.lower() == "md":
+ # MD bfactor was computed as RMSF
+ # Convert to b-factor
+ bfactor = 8 * (np.pi**2) * (bfactor**2)
+
+ # We compute frames within ensemble
+ if compute_frames:
+ frames = []
+ frame_resolved_mask = []
+ for i in range(coord_data.shape[0]):
+ frame_data_, resolved_frame_data_ = compute_frames_nonpolymer(
+ data,
+ coord_data[i],
+ atom_data["is_present"],
+ atom_to_token,
+ frame_data,
+ resolved_frame_data,
+ ) # Compute frames for NONPOLYMER tokens
+ frames.append(frame_data_.copy())
+ frame_resolved_mask.append(resolved_frame_data_.copy())
+ frames = from_numpy(np.stack(frames)) # (N_ENS, N_TOK, 3)
+ frame_resolved_mask = from_numpy(np.stack(frame_resolved_mask))
+
+ # Convert to one-hot
+ backbone_feat_index = one_hot(
+ backbone_feat_index,
+ num_classes=1
+ + len(const.protein_backbone_atom_index)
+ + len(const.nucleic_backbone_atom_index),
+ )
+ ref_atom_name_chars = one_hot(ref_atom_name_chars, num_classes=64)
+ ref_element = one_hot(ref_element, num_classes=const.num_elements)
+ atom_to_token = one_hot(atom_to_token, num_classes=token_id + 1)
+ token_to_rep_atom = one_hot(token_to_rep_atom, num_classes=len(atom_data))
+ r_set_to_rep_atom = one_hot(r_set_to_rep_atom, num_classes=len(atom_data))
+ token_to_center_atom = one_hot(token_to_center_atom, num_classes=len(atom_data))
+
+ # Center the ground truth coordinates
+ center = (coords * resolved_mask[None, :, None]).sum(dim=1)
+ center = center / resolved_mask.sum().clamp(min=1)
+ coords = coords - center[:, None]
+
+ if isinstance(override_coords, Tensor):
+ coords = override_coords.unsqueeze(0)
+
+ # Apply random roto-translation to the input conformers
+ for i in range(torch.max(ref_space_uid)):
+ included = ref_space_uid == i
+ if torch.sum(included) > 0 and torch.any(resolved_mask[included]):
+ ref_pos[included] = center_random_augmentation(
+ ref_pos[included][None], resolved_mask[included][None], centering=True
+ )[0]
+
+ # Compute padding and apply
+ if max_atoms is not None:
+ assert max_atoms % atoms_per_window_queries == 0
+ pad_len = max_atoms - len(atom_data)
+ else:
+ pad_len = (
+ (len(atom_data) - 1) // atoms_per_window_queries + 1
+ ) * atoms_per_window_queries - len(atom_data)
+
+ if pad_len > 0:
+ pad_mask = pad_dim(pad_mask, 0, pad_len)
+ ref_pos = pad_dim(ref_pos, 0, pad_len)
+ resolved_mask = pad_dim(resolved_mask, 0, pad_len)
+ ref_atom_name_chars = pad_dim(ref_atom_name_chars, 0, pad_len)
+ ref_element = pad_dim(ref_element, 0, pad_len)
+ ref_charge = pad_dim(ref_charge, 0, pad_len)
+ ref_chirality = pad_dim(ref_chirality, 0, pad_len)
+ backbone_feat_index = pad_dim(backbone_feat_index, 0, pad_len)
+ ref_space_uid = pad_dim(ref_space_uid, 0, pad_len)
+ coords = pad_dim(coords, 1, pad_len)
+ atom_to_token = pad_dim(atom_to_token, 0, pad_len)
+ token_to_rep_atom = pad_dim(token_to_rep_atom, 1, pad_len)
+ token_to_center_atom = pad_dim(token_to_center_atom, 1, pad_len)
+ r_set_to_rep_atom = pad_dim(r_set_to_rep_atom, 1, pad_len)
+ bfactor = pad_dim(bfactor, 0, pad_len)
+ plddt = pad_dim(plddt, 0, pad_len)
+
+ if max_tokens is not None:
+ pad_len = max_tokens - token_to_rep_atom.shape[0]
+ if pad_len > 0:
+ atom_to_token = pad_dim(atom_to_token, 1, pad_len)
+ token_to_rep_atom = pad_dim(token_to_rep_atom, 0, pad_len)
+ r_set_to_rep_atom = pad_dim(r_set_to_rep_atom, 0, pad_len)
+ token_to_center_atom = pad_dim(token_to_center_atom, 0, pad_len)
+ disto_target = pad_dim(pad_dim(disto_target, 0, pad_len), 1, pad_len)
+ disto_coords_ensemble = pad_dim(disto_coords_ensemble, 1, pad_len)
+
+ if compute_frames:
+ frames = pad_dim(frames, 1, pad_len)
+ frame_resolved_mask = pad_dim(frame_resolved_mask, 1, pad_len)
+
+ atom_features = {
+ "ref_pos": ref_pos,
+ "atom_resolved_mask": resolved_mask,
+ "ref_atom_name_chars": ref_atom_name_chars,
+ "ref_element": ref_element,
+ "ref_charge": ref_charge,
+ "ref_chirality": ref_chirality,
+ "atom_backbone_feat": backbone_feat_index,
+ "ref_space_uid": ref_space_uid,
+ "coords": coords,
+ "atom_pad_mask": pad_mask,
+ "atom_to_token": atom_to_token,
+ "token_to_rep_atom": token_to_rep_atom,
+ "r_set_to_rep_atom": r_set_to_rep_atom,
+ "token_to_center_atom": token_to_center_atom,
+ "disto_target": disto_target,
+ "disto_coords_ensemble": disto_coords_ensemble,
+ "bfactor": bfactor,
+ "plddt": plddt,
+ }
+
+ if compute_frames:
+ atom_features["frames_idx"] = frames
+ atom_features["frame_resolved_mask"] = frame_resolved_mask
+
+ return atom_features
+
+
+def process_msa_features(
+ data: Tokenized,
+ random: np.random.Generator,
+ max_seqs_batch: int,
+ max_seqs: int,
+ max_tokens: Optional[int] = None,
+ pad_to_max_seqs: bool = False,
+ msa_sampling: bool = False,
+ affinity: bool = False,
+) -> dict[str, Tensor]:
+ """Get the MSA features.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The input to the model.
+ random : np.random.Generator
+ The random number generator.
+ max_seqs : int
+ The maximum number of MSA sequences.
+ max_tokens : int
+ The maximum number of tokens.
+ pad_to_max_seqs : bool
+ Whether to pad to the maximum number of sequences.
+ msa_sampling : bool
+ Whether to sample the MSA.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The MSA features.
+
+ """
+ # Created paired MSA
+ msa, deletion, paired = construct_paired_msa(
+ data=data,
+ random=random,
+ max_seqs=max_seqs_batch,
+ random_subset=msa_sampling,
+ )
+ msa, deletion, paired = (
+ msa.transpose(1, 0),
+ deletion.transpose(1, 0),
+ paired.transpose(1, 0),
+ ) # (N_MSA, N_RES, N_AA)
+
+ # Prepare features
+ assert torch.all(msa >= 0) and torch.all(msa < const.num_tokens)
+ msa_one_hot = torch.nn.functional.one_hot(msa, num_classes=const.num_tokens)
+ msa_mask = torch.ones_like(msa)
+ profile = msa_one_hot.float().mean(dim=0)
+ has_deletion = deletion > 0
+ deletion = np.pi / 2 * np.arctan(deletion / 3)
+ deletion_mean = deletion.mean(axis=0)
+
+ # Pad in the MSA dimension (dim=0)
+ if pad_to_max_seqs:
+ pad_len = max_seqs - msa.shape[0]
+ if pad_len > 0:
+ msa = pad_dim(msa, 0, pad_len, const.token_ids["-"])
+ paired = pad_dim(paired, 0, pad_len)
+ msa_mask = pad_dim(msa_mask, 0, pad_len)
+ has_deletion = pad_dim(has_deletion, 0, pad_len)
+ deletion = pad_dim(deletion, 0, pad_len)
+
+ # Pad in the token dimension (dim=1)
+ if max_tokens is not None:
+ pad_len = max_tokens - msa.shape[1]
+ if pad_len > 0:
+ msa = pad_dim(msa, 1, pad_len, const.token_ids["-"])
+ paired = pad_dim(paired, 1, pad_len)
+ msa_mask = pad_dim(msa_mask, 1, pad_len)
+ has_deletion = pad_dim(has_deletion, 1, pad_len)
+ deletion = pad_dim(deletion, 1, pad_len)
+ profile = pad_dim(profile, 0, pad_len)
+ deletion_mean = pad_dim(deletion_mean, 0, pad_len)
+ if affinity:
+ return {
+ "deletion_mean_affinity": deletion_mean,
+ "profile_affinity": profile,
+ }
+ else:
+ return {
+ "msa": msa,
+ "msa_paired": paired,
+ "deletion_value": deletion,
+ "has_deletion": has_deletion,
+ "deletion_mean": deletion_mean,
+ "profile": profile,
+ "msa_mask": msa_mask,
+ }
+
+
+def load_dummy_templates_features(tdim: int, num_tokens: int) -> dict:
+ """Load dummy templates for v2."""
+ # Allocate features
+ res_type = np.zeros((tdim, num_tokens), dtype=np.int64)
+ frame_rot = np.zeros((tdim, num_tokens, 3, 3), dtype=np.float32)
+ frame_t = np.zeros((tdim, num_tokens, 3), dtype=np.float32)
+ cb_coords = np.zeros((tdim, num_tokens, 3), dtype=np.float32)
+ ca_coords = np.zeros((tdim, num_tokens, 3), dtype=np.float32)
+ frame_mask = np.zeros((tdim, num_tokens), dtype=np.float32)
+ cb_mask = np.zeros((tdim, num_tokens), dtype=np.float32)
+ template_mask = np.zeros((tdim, num_tokens), dtype=np.float32)
+ query_to_template = np.zeros((tdim, num_tokens), dtype=np.int64)
+ visibility_ids = np.zeros((tdim, num_tokens), dtype=np.float32)
+
+ # Convert to one-hot
+ res_type = torch.from_numpy(res_type)
+ res_type = one_hot(res_type, num_classes=const.num_tokens)
+
+ return {
+ "template_restype": res_type,
+ "template_frame_rot": torch.from_numpy(frame_rot),
+ "template_frame_t": torch.from_numpy(frame_t),
+ "template_cb": torch.from_numpy(cb_coords),
+ "template_ca": torch.from_numpy(ca_coords),
+ "template_mask_cb": torch.from_numpy(cb_mask),
+ "template_mask_frame": torch.from_numpy(frame_mask),
+ "template_mask": torch.from_numpy(template_mask),
+ "query_to_template": torch.from_numpy(query_to_template),
+ "visibility_ids": torch.from_numpy(visibility_ids),
+ }
+
+
+def compute_template_features(
+ query_tokens: Tokenized,
+ tmpl_tokens: list[dict],
+ num_tokens: int,
+) -> dict:
+ """Compute the template features."""
+ # Allocate features
+ res_type = np.zeros((num_tokens,), dtype=np.int64)
+ frame_rot = np.zeros((num_tokens, 3, 3), dtype=np.float32)
+ frame_t = np.zeros((num_tokens, 3), dtype=np.float32)
+ cb_coords = np.zeros((num_tokens, 3), dtype=np.float32)
+ ca_coords = np.zeros((num_tokens, 3), dtype=np.float32)
+ frame_mask = np.zeros((num_tokens,), dtype=np.float32)
+ cb_mask = np.zeros((num_tokens,), dtype=np.float32)
+ template_mask = np.zeros((num_tokens,), dtype=np.float32)
+ query_to_template = np.zeros((num_tokens,), dtype=np.int64)
+ visibility_ids = np.zeros((num_tokens,), dtype=np.float32)
+
+ # Now create features per token
+ asym_id_to_pdb_id = {}
+
+ for token_dict in tmpl_tokens:
+ idx = token_dict["q_idx"]
+ pdb_id = token_dict["pdb_id"]
+ token = token_dict["token"]
+ query_token = query_tokens.tokens[idx]
+ asym_id_to_pdb_id[query_token["asym_id"]] = pdb_id
+ res_type[idx] = token["res_type"]
+ frame_rot[idx] = token["frame_rot"].reshape(3, 3)
+ frame_t[idx] = token["frame_t"]
+ cb_coords[idx] = token["disto_coords"]
+ ca_coords[idx] = token["center_coords"]
+ cb_mask[idx] = token["disto_mask"]
+ frame_mask[idx] = token["frame_mask"]
+ template_mask[idx] = 1.0
+
+ # Set visibility_id for templated chains
+ for asym_id, pdb_id in asym_id_to_pdb_id.items():
+ indices = (query_tokens.tokens["asym_id"] == asym_id).nonzero()
+ visibility_ids[indices] = pdb_id
+
+ # Set visibility for non templated chain + olygomerics
+ for asym_id in np.unique(query_tokens.structure.chains["asym_id"]):
+ if asym_id not in asym_id_to_pdb_id:
+ # We hack the chain id to be negative to not overlap with the above
+ indices = (query_tokens.tokens["asym_id"] == asym_id).nonzero()
+ visibility_ids[indices] = -1 - asym_id
+
+ # Convert to one-hot
+ res_type = torch.from_numpy(res_type)
+ res_type = one_hot(res_type, num_classes=const.num_tokens)
+
+ return {
+ "template_restype": res_type,
+ "template_frame_rot": torch.from_numpy(frame_rot),
+ "template_frame_t": torch.from_numpy(frame_t),
+ "template_cb": torch.from_numpy(cb_coords),
+ "template_ca": torch.from_numpy(ca_coords),
+ "template_mask_cb": torch.from_numpy(cb_mask),
+ "template_mask_frame": torch.from_numpy(frame_mask),
+ "template_mask": torch.from_numpy(template_mask),
+ "query_to_template": torch.from_numpy(query_to_template),
+ "visibility_ids": torch.from_numpy(visibility_ids),
+ }
+
+
+def process_template_features(
+ data: Tokenized,
+ max_tokens: int,
+) -> dict[str, torch.Tensor]:
+ """Load the given input data.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The input to the model.
+ max_tokens : int
+ The maximum number of tokens.
+
+ Returns
+ -------
+ dict[str, torch.Tensor]
+ The loaded template features.
+
+ """
+ # Group templates by name
+ name_to_templates: dict[str, list[TemplateInfo]] = {}
+ for template_info in data.record.templates:
+ name_to_templates.setdefault(template_info.name, []).append(template_info)
+
+ # Map chain name to asym_id
+ chain_name_to_asym_id = {}
+ for chain in data.structure.chains:
+ chain_name_to_asym_id[chain["name"]] = chain["asym_id"]
+
+ # Compute the offset
+ template_features = []
+ for template_id, (template_name, templates) in enumerate(name_to_templates.items()):
+ row_tokens = []
+ template_structure = data.templates[template_name]
+ template_tokens = data.template_tokens[template_name]
+ tmpl_chain_name_to_asym_id = {}
+ for chain in template_structure.chains:
+ tmpl_chain_name_to_asym_id[chain["name"]] = chain["asym_id"]
+
+ for template in templates:
+ offset = template.template_st - template.query_st
+
+ # Get query and template tokens to map residues
+ query_tokens = data.tokens
+ chain_id = chain_name_to_asym_id[template.query_chain]
+ q_tokens = query_tokens[query_tokens["asym_id"] == chain_id]
+ q_indices = dict(zip(q_tokens["res_idx"], q_tokens["token_idx"]))
+
+ # Get the template tokens at the query residues
+ chain_id = tmpl_chain_name_to_asym_id[template.template_chain]
+ toks = template_tokens[template_tokens["asym_id"] == chain_id]
+ toks = [t for t in toks if t["res_idx"] - offset in q_indices]
+ for t in toks:
+ q_idx = q_indices[t["res_idx"] - offset]
+ row_tokens.append(
+ {
+ "token": t,
+ "pdb_id": template_id,
+ "q_idx": q_idx,
+ }
+ )
+
+ # Compute template features for each row
+ row_features = compute_template_features(data, row_tokens, max_tokens)
+ row_features["template_force"] = torch.tensor(template.force)
+ row_features["template_force_threshold"] = torch.tensor(
+ template.threshold if template.threshold is not None else float("inf"),
+ dtype=torch.float32,
+ )
+ template_features.append(row_features)
+
+ # Stack each feature
+ out = {}
+ for k in template_features[0]:
+ out[k] = torch.stack([f[k] for f in template_features])
+ return out
+
+
+def process_symmetry_features(
+ cropped: Tokenized, symmetries: dict
+) -> dict[str, Tensor]:
+ """Get the symmetry features.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The input to the model.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The symmetry features.
+
+ """
+ features = get_chain_symmetries(cropped)
+ features.update(get_amino_acids_symmetries(cropped))
+ features.update(get_ligand_symmetries(cropped, symmetries))
+
+ return features
+
+
+def process_ensemble_features(
+ data: Tokenized,
+ random: np.random.Generator,
+ num_ensembles: int,
+ ensemble_sample_replacement: bool,
+ fix_single_ensemble: bool,
+) -> dict[str, Tensor]:
+ """Get the ensemble features.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The input to the model.
+ random : np.random.Generator
+ The random number generator.
+ num_ensembles : int
+ The maximum number of ensembles to sample.
+ ensemble_sample_replacement : bool
+ Whether to sample with replacement.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The ensemble features.
+
+ """
+ assert num_ensembles > 0, "Number of conformers sampled must be greater than 0."
+
+ # Number of available conformers in the structure
+ # s_ensemble_num = min(len(cropped.structure.ensemble), 24) # Limit to 24 conformers DEBUG: TODO: remove !
+ s_ensemble_num = len(data.structure.ensemble)
+
+ if fix_single_ensemble:
+ # Always take the first conformer for train and validation
+ assert num_ensembles == 1, (
+ "Number of conformers sampled must be 1 with fix_single_ensemble=True."
+ )
+ ensemble_ref_idxs = np.array([0])
+ else:
+ if ensemble_sample_replacement:
+ # Used in training
+ ensemble_ref_idxs = random.integers(0, s_ensemble_num, (num_ensembles,))
+ else:
+ # Used in validation
+ if s_ensemble_num < num_ensembles:
+ # Take all available conformers
+ ensemble_ref_idxs = np.arange(0, s_ensemble_num)
+ else:
+ # Sample without replacement
+ ensemble_ref_idxs = random.choice(
+ s_ensemble_num, num_ensembles, replace=False
+ )
+
+ ensemble_features = {
+ "ensemble_ref_idxs": torch.Tensor(ensemble_ref_idxs).long(),
+ }
+
+ return ensemble_features
+
+
+def process_residue_constraint_features(data: Tokenized) -> dict[str, Tensor]:
+ residue_constraints = data.residue_constraints
+ if residue_constraints is not None:
+ rdkit_bounds_constraints = residue_constraints.rdkit_bounds_constraints
+ chiral_atom_constraints = residue_constraints.chiral_atom_constraints
+ stereo_bond_constraints = residue_constraints.stereo_bond_constraints
+ planar_bond_constraints = residue_constraints.planar_bond_constraints
+ planar_ring_5_constraints = residue_constraints.planar_ring_5_constraints
+ planar_ring_6_constraints = residue_constraints.planar_ring_6_constraints
+
+ rdkit_bounds_index = torch.tensor(
+ rdkit_bounds_constraints["atom_idxs"].copy(), dtype=torch.long
+ ).T
+ rdkit_bounds_bond_mask = torch.tensor(
+ rdkit_bounds_constraints["is_bond"].copy(), dtype=torch.bool
+ )
+ rdkit_bounds_angle_mask = torch.tensor(
+ rdkit_bounds_constraints["is_angle"].copy(), dtype=torch.bool
+ )
+ rdkit_upper_bounds = torch.tensor(
+ rdkit_bounds_constraints["upper_bound"].copy(), dtype=torch.float
+ )
+ rdkit_lower_bounds = torch.tensor(
+ rdkit_bounds_constraints["lower_bound"].copy(), dtype=torch.float
+ )
+
+ chiral_atom_index = torch.tensor(
+ chiral_atom_constraints["atom_idxs"].copy(), dtype=torch.long
+ ).T
+ chiral_reference_mask = torch.tensor(
+ chiral_atom_constraints["is_reference"].copy(), dtype=torch.bool
+ )
+ chiral_atom_orientations = torch.tensor(
+ chiral_atom_constraints["is_r"].copy(), dtype=torch.bool
+ )
+
+ stereo_bond_index = torch.tensor(
+ stereo_bond_constraints["atom_idxs"].copy(), dtype=torch.long
+ ).T
+ stereo_reference_mask = torch.tensor(
+ stereo_bond_constraints["is_reference"].copy(), dtype=torch.bool
+ )
+ stereo_bond_orientations = torch.tensor(
+ stereo_bond_constraints["is_e"].copy(), dtype=torch.bool
+ )
+
+ planar_bond_index = torch.tensor(
+ planar_bond_constraints["atom_idxs"].copy(), dtype=torch.long
+ ).T
+ planar_ring_5_index = torch.tensor(
+ planar_ring_5_constraints["atom_idxs"].copy(), dtype=torch.long
+ ).T
+ planar_ring_6_index = torch.tensor(
+ planar_ring_6_constraints["atom_idxs"].copy(), dtype=torch.long
+ ).T
+ else:
+ rdkit_bounds_index = torch.empty((2, 0), dtype=torch.long)
+ rdkit_bounds_bond_mask = torch.empty((0,), dtype=torch.bool)
+ rdkit_bounds_angle_mask = torch.empty((0,), dtype=torch.bool)
+ rdkit_upper_bounds = torch.empty((0,), dtype=torch.float)
+ rdkit_lower_bounds = torch.empty((0,), dtype=torch.float)
+ chiral_atom_index = torch.empty(
+ (
+ 4,
+ 0,
+ ),
+ dtype=torch.long,
+ )
+ chiral_reference_mask = torch.empty((0,), dtype=torch.bool)
+ chiral_atom_orientations = torch.empty((0,), dtype=torch.bool)
+ stereo_bond_index = torch.empty((4, 0), dtype=torch.long)
+ stereo_reference_mask = torch.empty((0,), dtype=torch.bool)
+ stereo_bond_orientations = torch.empty((0,), dtype=torch.bool)
+ planar_bond_index = torch.empty((6, 0), dtype=torch.long)
+ planar_ring_5_index = torch.empty((5, 0), dtype=torch.long)
+ planar_ring_6_index = torch.empty((6, 0), dtype=torch.long)
+
+ return {
+ "rdkit_bounds_index": rdkit_bounds_index,
+ "rdkit_bounds_bond_mask": rdkit_bounds_bond_mask,
+ "rdkit_bounds_angle_mask": rdkit_bounds_angle_mask,
+ "rdkit_upper_bounds": rdkit_upper_bounds,
+ "rdkit_lower_bounds": rdkit_lower_bounds,
+ "chiral_atom_index": chiral_atom_index,
+ "chiral_reference_mask": chiral_reference_mask,
+ "chiral_atom_orientations": chiral_atom_orientations,
+ "stereo_bond_index": stereo_bond_index,
+ "stereo_reference_mask": stereo_reference_mask,
+ "stereo_bond_orientations": stereo_bond_orientations,
+ "planar_bond_index": planar_bond_index,
+ "planar_ring_5_index": planar_ring_5_index,
+ "planar_ring_6_index": planar_ring_6_index,
+ }
+
+
+def process_chain_feature_constraints(data: Tokenized) -> dict[str, Tensor]:
+ structure = data.structure
+ if structure.bonds.shape[0] > 0:
+ connected_chain_index, connected_atom_index = [], []
+ for connection in structure.bonds:
+ if connection["chain_1"] == connection["chain_2"]:
+ continue
+ connected_chain_index.append([connection["chain_1"], connection["chain_2"]])
+ connected_atom_index.append([connection["atom_1"], connection["atom_2"]])
+ if len(connected_chain_index) > 0:
+ connected_chain_index = torch.tensor(
+ connected_chain_index, dtype=torch.long
+ ).T
+ connected_atom_index = torch.tensor(
+ connected_atom_index, dtype=torch.long
+ ).T
+ else:
+ connected_chain_index = torch.empty((2, 0), dtype=torch.long)
+ connected_atom_index = torch.empty((2, 0), dtype=torch.long)
+ else:
+ connected_chain_index = torch.empty((2, 0), dtype=torch.long)
+ connected_atom_index = torch.empty((2, 0), dtype=torch.long)
+
+ symmetric_chain_index = []
+ for i, chain_i in enumerate(structure.chains):
+ for j, chain_j in enumerate(structure.chains):
+ if j <= i:
+ continue
+ if chain_i["entity_id"] == chain_j["entity_id"]:
+ symmetric_chain_index.append([i, j])
+ if len(symmetric_chain_index) > 0:
+ symmetric_chain_index = torch.tensor(symmetric_chain_index, dtype=torch.long).T
+ else:
+ symmetric_chain_index = torch.empty((2, 0), dtype=torch.long)
+ return {
+ "connected_chain_index": connected_chain_index,
+ "connected_atom_index": connected_atom_index,
+ "symmetric_chain_index": symmetric_chain_index,
+ }
+
+
+def process_contact_feature_constraints(
+ data: Tokenized,
+ inference_pocket_constraints: list[tuple[int, list[tuple[int, int]], float]],
+ inference_contact_constraints: list[tuple[tuple[int, int], tuple[int, int], float]],
+):
+ token_data = data.tokens
+ union_idx = 0
+ pair_index, union_index, negation_mask, thresholds = [], [], [], []
+ for binder, contacts, max_distance, force in inference_pocket_constraints:
+ if not force:
+ continue
+
+ binder_chain = data.structure.chains[binder]
+ for token in token_data:
+ if (
+ token["mol_type"] != const.chain_type_ids["NONPOLYMER"]
+ and (token["asym_id"], token["res_idx"]) in contacts
+ ) or (
+ token["mol_type"] == const.chain_type_ids["NONPOLYMER"]
+ and (token["asym_id"], token["atom_idx"]) in contacts
+ ):
+ atom_idx_pairs = torch.cartesian_prod(
+ torch.arange(
+ binder_chain["atom_idx"],
+ binder_chain["atom_idx"] + binder_chain["atom_num"],
+ ),
+ torch.arange(
+ token["atom_idx"], token["atom_idx"] + token["atom_num"]
+ ),
+ ).T
+ pair_index.append(atom_idx_pairs)
+ union_index.append(torch.full((atom_idx_pairs.shape[1],), union_idx))
+ negation_mask.append(
+ torch.ones((atom_idx_pairs.shape[1],), dtype=torch.bool)
+ )
+ thresholds.append(torch.full((atom_idx_pairs.shape[1],), max_distance))
+ union_idx += 1
+
+ for token1, token2, max_distance, force in inference_contact_constraints:
+ if not force:
+ continue
+
+ for idx1, _token1 in enumerate(token_data):
+ if (
+ _token1["mol_type"] != const.chain_type_ids["NONPOLYMER"]
+ and (_token1["asym_id"], _token1["res_idx"]) == token1
+ ) or (
+ _token1["mol_type"] == const.chain_type_ids["NONPOLYMER"]
+ and (_token1["asym_id"], _token1["atom_idx"]) == token1
+ ):
+ for idx2, _token2 in enumerate(token_data):
+ if (
+ _token2["mol_type"] != const.chain_type_ids["NONPOLYMER"]
+ and (_token2["asym_id"], _token2["res_idx"]) == token2
+ ) or (
+ _token2["mol_type"] == const.chain_type_ids["NONPOLYMER"]
+ and (_token2["asym_id"], _token2["atom_idx"]) == token2
+ ):
+ atom_idx_pairs = torch.cartesian_prod(
+ torch.arange(
+ _token1["atom_idx"],
+ _token1["atom_idx"] + _token1["atom_num"],
+ ),
+ torch.arange(
+ _token2["atom_idx"],
+ _token2["atom_idx"] + _token2["atom_num"],
+ ),
+ ).T
+ pair_index.append(atom_idx_pairs)
+ union_index.append(
+ torch.full((atom_idx_pairs.shape[1],), union_idx)
+ )
+ negation_mask.append(
+ torch.ones((atom_idx_pairs.shape[1],), dtype=torch.bool)
+ )
+ thresholds.append(
+ torch.full((atom_idx_pairs.shape[1],), max_distance)
+ )
+ union_idx += 1
+ break
+ break
+
+ if len(pair_index) > 0:
+ pair_index = torch.cat(pair_index, dim=1)
+ union_index = torch.cat(union_index)
+ negation_mask = torch.cat(negation_mask)
+ thresholds = torch.cat(thresholds)
+ else:
+ pair_index = torch.empty((2, 0), dtype=torch.long)
+ union_index = torch.empty((0,), dtype=torch.long)
+ negation_mask = torch.empty((0,), dtype=torch.bool)
+ thresholds = torch.empty((0,), dtype=torch.float32)
+
+ return {
+ "contact_pair_index": pair_index,
+ "contact_union_index": union_index,
+ "contact_negation_mask": negation_mask,
+ "contact_thresholds": thresholds,
+ }
+
+
+class Boltz2Featurizer:
+ """Boltz2 featurizer."""
+
+ def process(
+ self,
+ data: Tokenized,
+ random: np.random.Generator,
+ molecules: dict[str, Mol],
+ training: bool,
+ max_seqs: int,
+ atoms_per_window_queries: int = 32,
+ min_dist: float = 2.0,
+ max_dist: float = 22.0,
+ num_bins: int = 64,
+ num_ensembles: int = 1,
+ ensemble_sample_replacement: bool = False,
+ disto_use_ensemble: Optional[bool] = False,
+ fix_single_ensemble: Optional[bool] = True,
+ max_tokens: Optional[int] = None,
+ max_atoms: Optional[int] = None,
+ pad_to_max_seqs: bool = False,
+ compute_symmetries: bool = False,
+ binder_pocket_conditioned_prop: Optional[float] = 0.0,
+ contact_conditioned_prop: Optional[float] = 0.0,
+ binder_pocket_cutoff_min: Optional[float] = 4.0,
+ binder_pocket_cutoff_max: Optional[float] = 20.0,
+ binder_pocket_sampling_geometric_p: Optional[float] = 0.0,
+ only_ligand_binder_pocket: Optional[bool] = False,
+ only_pp_contact: Optional[bool] = False,
+ single_sequence_prop: Optional[float] = 0.0,
+ msa_sampling: bool = False,
+ override_bfactor: float = False,
+ override_method: Optional[str] = None,
+ compute_frames: bool = False,
+ override_coords: Optional[Tensor] = None,
+ bfactor_md_correction: bool = False,
+ compute_constraint_features: bool = False,
+ inference_pocket_constraints: Optional[
+ list[tuple[int, list[tuple[int, int]], float]]
+ ] = None,
+ inference_contact_constraints: Optional[
+ list[tuple[tuple[int, int], tuple[int, int], float]]
+ ] = None,
+ compute_affinity: bool = False,
+ ) -> dict[str, Tensor]:
+ """Compute features.
+
+ Parameters
+ ----------
+ data : Tokenized
+ The input to the model.
+ training : bool
+ Whether the model is in training mode.
+ max_tokens : int, optional
+ The maximum number of tokens.
+ max_atoms : int, optional
+ The maximum number of atoms
+ max_seqs : int, optional
+ The maximum number of sequences.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The features for model training.
+
+ """
+ # Compute random number of sequences
+ if training and max_seqs is not None:
+ if random.random() > single_sequence_prop:
+ max_seqs_batch = random.integers(1, max_seqs + 1)
+ else:
+ max_seqs_batch = 1
+ else:
+ max_seqs_batch = max_seqs
+
+ # Compute ensemble features
+ ensemble_features = process_ensemble_features(
+ data=data,
+ random=random,
+ num_ensembles=num_ensembles,
+ ensemble_sample_replacement=ensemble_sample_replacement,
+ fix_single_ensemble=fix_single_ensemble,
+ )
+
+ # Compute token features
+ token_features = process_token_features(
+ data=data,
+ random=random,
+ max_tokens=max_tokens,
+ binder_pocket_conditioned_prop=binder_pocket_conditioned_prop,
+ contact_conditioned_prop=contact_conditioned_prop,
+ binder_pocket_cutoff_min=binder_pocket_cutoff_min,
+ binder_pocket_cutoff_max=binder_pocket_cutoff_max,
+ binder_pocket_sampling_geometric_p=binder_pocket_sampling_geometric_p,
+ only_ligand_binder_pocket=only_ligand_binder_pocket,
+ only_pp_contact=only_pp_contact,
+ override_method=override_method,
+ inference_pocket_constraints=inference_pocket_constraints,
+ inference_contact_constraints=inference_contact_constraints,
+ )
+
+ # Compute atom features
+ atom_features = process_atom_features(
+ data=data,
+ random=random,
+ molecules=molecules,
+ ensemble_features=ensemble_features,
+ atoms_per_window_queries=atoms_per_window_queries,
+ min_dist=min_dist,
+ max_dist=max_dist,
+ num_bins=num_bins,
+ max_atoms=max_atoms,
+ max_tokens=max_tokens,
+ disto_use_ensemble=disto_use_ensemble,
+ override_bfactor=override_bfactor,
+ compute_frames=compute_frames,
+ override_coords=override_coords,
+ bfactor_md_correction=bfactor_md_correction,
+ )
+
+ # Compute MSA features
+ msa_features = process_msa_features(
+ data=data,
+ random=random,
+ max_seqs_batch=max_seqs_batch,
+ max_seqs=max_seqs,
+ max_tokens=max_tokens,
+ pad_to_max_seqs=pad_to_max_seqs,
+ msa_sampling=training and msa_sampling,
+ )
+
+ # Compute MSA features
+ msa_features_affinity = {}
+ if compute_affinity:
+ msa_features_affinity = process_msa_features(
+ data=data,
+ random=random,
+ max_seqs_batch=1,
+ max_seqs=1,
+ max_tokens=max_tokens,
+ pad_to_max_seqs=pad_to_max_seqs,
+ msa_sampling=training and msa_sampling,
+ affinity=True,
+ )
+
+ # Compute affinity ligand Molecular Weight
+ ligand_to_mw = {}
+ if compute_affinity:
+ ligand_to_mw["affinity_mw"] = data.record.affinity.mw
+
+ # Compute template features
+ num_tokens = data.tokens.shape[0] if max_tokens is None else max_tokens
+ if data.templates:
+ template_features = process_template_features(
+ data=data,
+ max_tokens=num_tokens,
+ )
+ else:
+ template_features = load_dummy_templates_features(
+ tdim=1,
+ num_tokens=num_tokens,
+ )
+
+ # Compute symmetry features
+ symmetry_features = {}
+ if compute_symmetries:
+ symmetries = get_symmetries(molecules)
+ symmetry_features = process_symmetry_features(data, symmetries)
+
+ # Compute constraint features
+ residue_constraint_features = {}
+ chain_constraint_features = {}
+ contact_constraint_features = {}
+ if compute_constraint_features:
+ residue_constraint_features = process_residue_constraint_features(data)
+ chain_constraint_features = process_chain_feature_constraints(data)
+ contact_constraint_features = process_contact_feature_constraints(
+ data=data,
+ inference_pocket_constraints=inference_pocket_constraints if inference_pocket_constraints else [],
+ inference_contact_constraints=inference_contact_constraints if inference_contact_constraints else [],
+ )
+
+ return {
+ **token_features,
+ **atom_features,
+ **msa_features,
+ **msa_features_affinity,
+ **template_features,
+ **symmetry_features,
+ **ensemble_features,
+ **residue_constraint_features,
+ **chain_constraint_features,
+ **contact_constraint_features,
+ **ligand_to_mw,
+ }
diff --git a/forks/boltz/src/boltz/data/feature/symmetry.py b/forks/boltz/src/boltz/data/feature/symmetry.py
new file mode 100644
index 00000000..abde5977
--- /dev/null
+++ b/forks/boltz/src/boltz/data/feature/symmetry.py
@@ -0,0 +1,602 @@
+import itertools
+import pickle
+import random
+from pathlib import Path
+
+import numpy as np
+import torch
+
+from boltz.data import const
+from boltz.data.pad import pad_dim
+from boltz.model.loss.confidence import lddt_dist
+from boltz.model.loss.validation import weighted_minimum_rmsd_single
+
+
+def convert_atom_name(name: str) -> tuple[int, int, int, int]:
+ """Convert an atom name to a standard format.
+
+ Parameters
+ ----------
+ name : str
+ The atom name.
+
+ Returns
+ -------
+ Tuple[int, int, int, int]
+ The converted atom name.
+
+ """
+ name = name.strip()
+ name = [ord(c) - 32 for c in name]
+ name = name + [0] * (4 - len(name))
+ return tuple(name)
+
+
+def get_symmetries(path: str) -> dict:
+ """Create a dictionary for the ligand symmetries.
+
+ Parameters
+ ----------
+ path : str
+ The path to the ligand symmetries.
+
+ Returns
+ -------
+ dict
+ The ligand symmetries.
+
+ """
+ with Path(path).open("rb") as f:
+ data: dict = pickle.load(f) # noqa: S301
+
+ symmetries = {}
+ for key, mol in data.items():
+ try:
+ serialized_sym = bytes.fromhex(mol.GetProp("symmetries"))
+ sym = pickle.loads(serialized_sym) # noqa: S301
+ atom_names = []
+ for atom in mol.GetAtoms():
+ # Get atom name
+ atom_name = convert_atom_name(atom.GetProp("name"))
+ atom_names.append(atom_name)
+
+ symmetries[key] = (sym, atom_names)
+ except Exception: # noqa: BLE001, PERF203, S110
+ pass
+
+ return symmetries
+
+
+def compute_symmetry_idx_dictionary(data):
+ # Compute the symmetry index dictionary
+ total_count = 0
+ all_coords = []
+ for i, chain in enumerate(data.chains):
+ chain.start_idx = total_count
+ for j, token in enumerate(chain.tokens):
+ token.start_idx = total_count - chain.start_idx
+ all_coords.extend(
+ [[atom.coords.x, atom.coords.y, atom.coords.z] for atom in token.atoms]
+ )
+ total_count += len(token.atoms)
+ return all_coords
+
+
+def get_current_idx_list(data):
+ idx = []
+ for chain in data.chains:
+ if chain.in_crop:
+ for token in chain.tokens:
+ if token.in_crop:
+ idx.extend(
+ [
+ chain.start_idx + token.start_idx + i
+ for i in range(len(token.atoms))
+ ]
+ )
+ return idx
+
+
+def all_different_after_swap(l):
+ final = [s[-1] for s in l]
+ return len(final) == len(set(final))
+
+
+def minimum_symmetry_coords(
+ coords: torch.Tensor,
+ feats: dict,
+ index_batch: int,
+ **args_rmsd,
+):
+ all_coords = feats["all_coords"][index_batch].unsqueeze(0).to(coords)
+ all_resolved_mask = (
+ feats["all_resolved_mask"][index_batch].to(coords).to(torch.bool)
+ )
+ crop_to_all_atom_map = (
+ feats["crop_to_all_atom_map"][index_batch].to(coords).to(torch.long)
+ )
+ chain_symmetries = feats["chain_symmetries"][index_batch]
+ amino_acids_symmetries = feats["amino_acids_symmetries"][index_batch]
+ ligand_symmetries = feats["ligand_symmetries"][index_batch]
+
+ # Check best symmetry on chain swap
+ best_true_coords = None
+ best_rmsd = float("inf")
+ best_align_weights = None
+ for c in chain_symmetries:
+ true_all_coords = all_coords.clone()
+ true_all_resolved_mask = all_resolved_mask.clone()
+ for start1, end1, start2, end2, chainidx1, chainidx2 in c:
+ true_all_coords[:, start1:end1] = all_coords[:, start2:end2]
+ true_all_resolved_mask[start1:end1] = all_resolved_mask[start2:end2]
+ true_coords = true_all_coords[:, crop_to_all_atom_map]
+ true_resolved_mask = true_all_resolved_mask[crop_to_all_atom_map]
+ true_coords = pad_dim(true_coords, 1, coords.shape[1] - true_coords.shape[1])
+ true_resolved_mask = pad_dim(
+ true_resolved_mask,
+ 0,
+ coords.shape[1] - true_resolved_mask.shape[0],
+ )
+ try:
+ rmsd, aligned_coords, align_weights = weighted_minimum_rmsd_single(
+ coords,
+ true_coords,
+ atom_mask=true_resolved_mask,
+ atom_to_token=feats["atom_to_token"][index_batch : index_batch + 1],
+ mol_type=feats["mol_type"][index_batch : index_batch + 1],
+ **args_rmsd,
+ )
+ except:
+ print("Warning: error in rmsd computation inside symmetry code")
+ continue
+ rmsd = rmsd.item()
+
+ if rmsd < best_rmsd:
+ best_rmsd = rmsd
+ best_true_coords = aligned_coords
+ best_align_weights = align_weights
+ best_true_resolved_mask = true_resolved_mask
+
+ # atom symmetries (nucleic acid and protein residues), resolved greedily without recomputing alignment
+ true_coords = best_true_coords.clone()
+ true_resolved_mask = best_true_resolved_mask.clone()
+ for symmetric_amino in amino_acids_symmetries:
+ for c in symmetric_amino:
+ # starting from greedy best, try to swap the atoms
+ new_true_coords = true_coords.clone()
+ new_true_resolved_mask = true_resolved_mask.clone()
+ for i, j in c:
+ new_true_coords[:, i] = true_coords[:, j]
+ new_true_resolved_mask[i] = true_resolved_mask[j]
+
+ # compute squared distance, for efficiency we do not recompute the alignment
+ best_mse_loss = torch.sum(
+ ((coords - best_true_coords) ** 2).sum(dim=-1)
+ * best_align_weights
+ * best_true_resolved_mask,
+ dim=-1,
+ ) / torch.sum(best_align_weights * best_true_resolved_mask, dim=-1)
+ new_mse_loss = torch.sum(
+ ((coords - new_true_coords) ** 2).sum(dim=-1)
+ * best_align_weights
+ * new_true_resolved_mask,
+ dim=-1,
+ ) / torch.sum(best_align_weights * new_true_resolved_mask, dim=-1)
+
+ if best_mse_loss > new_mse_loss:
+ best_true_coords = new_true_coords
+ best_true_resolved_mask = new_true_resolved_mask
+
+ # greedily update best coordinates after each amino acid
+ true_coords = best_true_coords.clone()
+ true_resolved_mask = best_true_resolved_mask.clone()
+
+ # Recomputing alignment
+ rmsd, true_coords, best_align_weights = weighted_minimum_rmsd_single(
+ coords,
+ true_coords,
+ atom_mask=true_resolved_mask,
+ atom_to_token=feats["atom_to_token"][index_batch : index_batch + 1],
+ mol_type=feats["mol_type"][index_batch : index_batch + 1],
+ **args_rmsd,
+ )
+ best_rmsd = rmsd.item()
+
+ # atom symmetries (ligand and non-standard), resolved greedily recomputing alignment
+ for symmetric_ligand in ligand_symmetries:
+ for c in symmetric_ligand:
+ new_true_coords = true_coords.clone()
+ new_true_resolved_mask = true_resolved_mask.clone()
+ for i, j in c:
+ new_true_coords[:, j] = true_coords[:, i]
+ new_true_resolved_mask[j] = true_resolved_mask[i]
+ try:
+ # TODO if this is too slow maybe we can get away with not recomputing alignment
+ rmsd, aligned_coords, align_weights = weighted_minimum_rmsd_single(
+ coords,
+ new_true_coords,
+ atom_mask=new_true_resolved_mask,
+ atom_to_token=feats["atom_to_token"][index_batch : index_batch + 1],
+ mol_type=feats["mol_type"][index_batch : index_batch + 1],
+ **args_rmsd,
+ )
+ except Exception as e:
+ raise e
+ print(e)
+ continue
+ rmsd = rmsd.item()
+ if rmsd < best_rmsd:
+ best_true_coords = aligned_coords
+ best_rmsd = rmsd
+ best_true_resolved_mask = new_true_resolved_mask
+
+ true_coords = best_true_coords.clone()
+ true_resolved_mask = best_true_resolved_mask.clone()
+
+ return best_true_coords, best_rmsd, best_true_resolved_mask.unsqueeze(0)
+
+
+def minimum_lddt_symmetry_coords(
+ coords: torch.Tensor,
+ feats: dict,
+ index_batch: int,
+ **args_rmsd,
+):
+ all_coords = feats["all_coords"][index_batch].unsqueeze(0).to(coords)
+ all_resolved_mask = (
+ feats["all_resolved_mask"][index_batch].to(coords).to(torch.bool)
+ )
+ crop_to_all_atom_map = (
+ feats["crop_to_all_atom_map"][index_batch].to(coords).to(torch.long)
+ )
+ chain_symmetries = feats["chain_symmetries"][index_batch]
+ amino_acids_symmetries = feats["amino_acids_symmetries"][index_batch]
+ ligand_symmetries = feats["ligand_symmetries"][index_batch]
+
+ dmat_predicted = torch.cdist(
+ coords[:, : len(crop_to_all_atom_map)], coords[:, : len(crop_to_all_atom_map)]
+ )
+
+ # Check best symmetry on chain swap
+ best_true_coords = None
+ best_lddt = 0
+ for c in chain_symmetries:
+ true_all_coords = all_coords.clone()
+ true_all_resolved_mask = all_resolved_mask.clone()
+ for start1, end1, start2, end2, chainidx1, chainidx2 in c:
+ true_all_coords[:, start1:end1] = all_coords[:, start2:end2]
+ true_all_resolved_mask[start1:end1] = all_resolved_mask[start2:end2]
+ true_coords = true_all_coords[:, crop_to_all_atom_map]
+ true_resolved_mask = true_all_resolved_mask[crop_to_all_atom_map]
+ dmat_true = torch.cdist(true_coords, true_coords)
+ pair_mask = (
+ true_resolved_mask[:, None]
+ * true_resolved_mask[None, :]
+ * (1 - torch.eye(len(true_resolved_mask))).to(true_resolved_mask)
+ )
+
+ lddt = lddt_dist(
+ dmat_predicted, dmat_true, pair_mask, cutoff=15.0, per_atom=False
+ )[0]
+ lddt = lddt.item()
+
+ if lddt > best_lddt:
+ best_lddt = lddt
+ best_true_coords = true_coords
+ best_true_resolved_mask = true_resolved_mask
+
+ # atom symmetries (nucleic acid and protein residues), resolved greedily without recomputing alignment
+ true_coords = best_true_coords.clone()
+ true_resolved_mask = best_true_resolved_mask.clone()
+ for symmetric_amino_or_lig in amino_acids_symmetries + ligand_symmetries:
+ for c in symmetric_amino_or_lig:
+ # starting from greedy best, try to swap the atoms
+ new_true_coords = true_coords.clone()
+ new_true_resolved_mask = true_resolved_mask.clone()
+ indices = []
+ for i, j in c:
+ new_true_coords[:, i] = true_coords[:, j]
+ new_true_resolved_mask[i] = true_resolved_mask[j]
+ indices.append(i)
+
+ indices = (
+ torch.from_numpy(np.asarray(indices)).to(new_true_coords.device).long()
+ )
+
+ pred_coords_subset = coords[:, : len(crop_to_all_atom_map)][:, indices]
+ true_coords_subset = true_coords[:, indices]
+ new_true_coords_subset = new_true_coords[:, indices]
+
+ sub_dmat_pred = torch.cdist(
+ coords[:, : len(crop_to_all_atom_map)], pred_coords_subset
+ )
+ sub_dmat_true = torch.cdist(true_coords, true_coords_subset)
+ sub_dmat_new_true = torch.cdist(new_true_coords, new_true_coords_subset)
+
+ sub_true_pair_lddt = (
+ true_resolved_mask[:, None] * true_resolved_mask[None, indices]
+ )
+ sub_true_pair_lddt[indices] = (
+ sub_true_pair_lddt[indices]
+ * (1 - torch.eye(len(indices))).to(sub_true_pair_lddt).bool()
+ )
+
+ sub_new_true_pair_lddt = (
+ new_true_resolved_mask[:, None] * new_true_resolved_mask[None, indices]
+ )
+ sub_new_true_pair_lddt[indices] = (
+ sub_new_true_pair_lddt[indices]
+ * (1 - torch.eye(len(indices))).to(sub_true_pair_lddt).bool()
+ )
+
+ lddt = lddt_dist(
+ sub_dmat_pred,
+ sub_dmat_true,
+ sub_true_pair_lddt,
+ cutoff=15.0,
+ per_atom=False,
+ )[0]
+ new_lddt = lddt_dist(
+ sub_dmat_pred,
+ sub_dmat_new_true,
+ sub_new_true_pair_lddt,
+ cutoff=15.0,
+ per_atom=False,
+ )[0]
+
+ if new_lddt > lddt:
+ best_true_coords = new_true_coords
+ best_true_resolved_mask = new_true_resolved_mask
+
+ # greedily update best coordinates after each amino acid
+ true_coords = best_true_coords.clone()
+ true_resolved_mask = best_true_resolved_mask.clone()
+
+ # Recomputing alignment
+ true_coords = pad_dim(true_coords, 1, coords.shape[1] - true_coords.shape[1])
+ true_resolved_mask = pad_dim(
+ true_resolved_mask,
+ 0,
+ coords.shape[1] - true_resolved_mask.shape[0],
+ )
+
+ try:
+ rmsd, true_coords, _ = weighted_minimum_rmsd_single(
+ coords,
+ true_coords,
+ atom_mask=true_resolved_mask,
+ atom_to_token=feats["atom_to_token"][index_batch : index_batch + 1],
+ mol_type=feats["mol_type"][index_batch : index_batch + 1],
+ **args_rmsd,
+ )
+ best_rmsd = rmsd.item()
+ except Exception as e:
+ print("Failed proper RMSD computation, returning inf. Error: ", e)
+ best_rmsd = 1000
+
+ return true_coords, best_rmsd, true_resolved_mask.unsqueeze(0)
+
+
+def compute_all_coords_mask(structure):
+ # Compute all coords, crop mask and add start_idx to structure
+ total_count = 0
+ all_coords = []
+ all_coords_crop_mask = []
+ all_resolved_mask = []
+ for i, chain in enumerate(structure.chains):
+ chain.start_idx = total_count
+ for j, token in enumerate(chain.tokens):
+ token.start_idx = total_count - chain.start_idx
+ all_coords.extend(
+ [[atom.coords.x, atom.coords.y, atom.coords.z] for atom in token.atoms]
+ )
+ all_coords_crop_mask.extend(
+ [token.in_crop for _ in range(len(token.atoms))]
+ )
+ all_resolved_mask.extend(
+ [token.is_present for _ in range(len(token.atoms))]
+ )
+ total_count += len(token.atoms)
+ if len(all_coords_crop_mask) != len(all_resolved_mask):
+ pass
+ return all_coords, all_coords_crop_mask, all_resolved_mask
+
+
+def get_chain_symmetries(cropped, max_n_symmetries=100):
+ # get all coordinates and resolved mask
+ structure = cropped.structure
+ all_coords = []
+ all_resolved_mask = []
+ original_atom_idx = []
+ chain_atom_idx = []
+ chain_atom_num = []
+ chain_in_crop = []
+ chain_asym_id = []
+ new_atom_idx = 0
+
+ for chain in structure.chains:
+ atom_idx, atom_num = (
+ chain["atom_idx"],
+ chain["atom_num"],
+ )
+
+ # compute coordinates and resolved mask
+ resolved_mask = structure.atoms["is_present"][atom_idx : atom_idx + atom_num]
+
+ # ensemble_atom_starts = [structure.ensemble[idx]["atom_coord_idx"] for idx in cropped.ensemble_ref_idxs]
+ # coords = np.array(
+ # [structure.coords[ensemble_atom_start + atom_idx: ensemble_atom_start + atom_idx + atom_num]["coords"] for
+ # ensemble_atom_start in ensemble_atom_starts])
+
+ coords = structure.atoms["coords"][atom_idx : atom_idx + atom_num]
+
+ in_crop = False
+ for token in cropped.tokens:
+ if token["asym_id"] == chain["asym_id"]:
+ in_crop = True
+ break
+
+ all_coords.append(coords)
+ all_resolved_mask.append(resolved_mask)
+ original_atom_idx.append(atom_idx)
+ chain_atom_idx.append(new_atom_idx)
+ chain_atom_num.append(atom_num)
+ chain_in_crop.append(in_crop)
+ chain_asym_id.append(chain["asym_id"])
+
+ new_atom_idx += atom_num
+
+ # Compute backmapping from token to all coords
+ crop_to_all_atom_map = []
+ for token in cropped.tokens:
+ chain_idx = chain_asym_id.index(token["asym_id"])
+ start = (
+ chain_atom_idx[chain_idx] - original_atom_idx[chain_idx] + token["atom_idx"]
+ )
+ crop_to_all_atom_map.append(np.arange(start, start + token["atom_num"]))
+
+ # Compute the symmetries between chains
+ swaps = []
+ for i, chain in enumerate(structure.chains):
+ start = chain_atom_idx[i]
+ end = start + chain_atom_num[i]
+ if chain_in_crop[i]:
+ possible_swaps = []
+ for j, chain2 in enumerate(structure.chains):
+ start2 = chain_atom_idx[j]
+ end2 = start2 + chain_atom_num[j]
+ if (
+ chain["entity_id"] == chain2["entity_id"]
+ and end - start == end2 - start2
+ ):
+ possible_swaps.append((start, end, start2, end2, i, j))
+ swaps.append(possible_swaps)
+ combinations = itertools.product(*swaps)
+ # to avoid combinatorial explosion, bound the number of combinations even considered
+ combinations = list(itertools.islice(combinations, max_n_symmetries * 10))
+ # filter for all chains getting a different assignment
+ combinations = [c for c in combinations if all_different_after_swap(c)]
+
+ if len(combinations) > max_n_symmetries:
+ combinations = random.sample(combinations, max_n_symmetries)
+
+ if len(combinations) == 0:
+ combinations.append([])
+
+ features = {}
+ features["all_coords"] = torch.Tensor(
+ np.concatenate(all_coords, axis=0)
+ ) # axis=1 with ensemble
+
+ features["all_resolved_mask"] = torch.Tensor(
+ np.concatenate(all_resolved_mask, axis=0)
+ )
+ features["crop_to_all_atom_map"] = torch.Tensor(
+ np.concatenate(crop_to_all_atom_map, axis=0)
+ )
+ features["chain_symmetries"] = combinations
+
+ return features
+
+
+def get_amino_acids_symmetries(cropped):
+ # Compute standard amino-acids symmetries
+ swaps = []
+ start_index_crop = 0
+ for token in cropped.tokens:
+ symmetries = const.ref_symmetries.get(const.tokens[token["res_type"]], [])
+ if len(symmetries) > 0:
+ residue_swaps = []
+ for sym in symmetries:
+ sym_new_idx = [
+ (i + start_index_crop, j + start_index_crop) for i, j in sym
+ ]
+ residue_swaps.append(sym_new_idx)
+ swaps.append(residue_swaps)
+ start_index_crop += token["atom_num"]
+
+ features = {"amino_acids_symmetries": swaps}
+ return features
+
+
+def get_ligand_symmetries(cropped, symmetries):
+ # Compute ligand and non-standard amino-acids symmetries
+ structure = cropped.structure
+
+ added_molecules = {}
+ index_mols = []
+ atom_count = 0
+ for token in cropped.tokens:
+ # check if molecule is already added by identifying it through asym_id and res_idx
+ atom_count += token["atom_num"]
+ mol_id = (token["asym_id"], token["res_idx"])
+ if mol_id in added_molecules.keys():
+ added_molecules[mol_id] += token["atom_num"]
+ continue
+ added_molecules[mol_id] = token["atom_num"]
+
+ # get the molecule type and indices
+ residue_idx = token["res_idx"] + structure.chains[token["asym_id"]]["res_idx"]
+ mol_name = structure.residues[residue_idx]["name"]
+ atom_idx = structure.residues[residue_idx]["atom_idx"]
+ mol_atom_names = structure.atoms[
+ atom_idx : atom_idx + structure.residues[residue_idx]["atom_num"]
+ ]["name"]
+ mol_atom_names = [tuple(m) for m in mol_atom_names]
+ if mol_name not in const.ref_symmetries.keys():
+ index_mols.append(
+ (mol_name, atom_count - token["atom_num"], mol_id, mol_atom_names)
+ )
+
+ # for each molecule, get the symmetries
+ molecule_symmetries = []
+ for mol_name, start_mol, mol_id, mol_atom_names in index_mols:
+ if not mol_name in symmetries:
+ continue
+ else:
+ swaps = []
+ syms_ccd, mol_atom_names_ccd = symmetries[mol_name]
+ # Get indices of mol_atom_names_ccd that are in mol_atom_names
+ ccd_to_valid_ids = {
+ mol_atom_names_ccd.index(name): i
+ for i, name in enumerate(mol_atom_names)
+ }
+ ccd_valid_ids = set(ccd_to_valid_ids.keys())
+
+ syms = []
+ # Get syms
+ for sym_ccd in syms_ccd:
+ sym_dict = {}
+ bool_add = True
+ for i, j in enumerate(sym_ccd):
+ if i in ccd_valid_ids:
+ if j in ccd_valid_ids:
+ i_true = ccd_to_valid_ids[i]
+ j_true = ccd_to_valid_ids[j]
+ sym_dict[i_true] = j_true
+ else:
+ bool_add = False
+ break
+ if bool_add:
+ syms.append([sym_dict[i] for i in range(len(ccd_valid_ids))])
+
+ for sym in syms:
+ if len(sym) != added_molecules[mol_id]:
+ raise Exception(
+ f"Symmetry length mismatch {len(sym)} {added_molecules[mol_id]}"
+ )
+ # assert (
+ # len(sym) == added_molecules[mol_id]
+ # ), f"Symmetry length mismatch {len(sym)} {added_molecules[mol_id]}"
+ sym_new_idx = []
+ for i, j in enumerate(sym):
+ if i != int(j):
+ sym_new_idx.append((i + start_mol, int(j) + start_mol))
+ if len(sym_new_idx) > 0:
+ swaps.append(sym_new_idx)
+ if len(swaps) > 0:
+ molecule_symmetries.append(swaps)
+
+ features = {"ligand_symmetries": molecule_symmetries}
+
+ return features
diff --git a/forks/boltz/src/boltz/data/filter/__init__.py b/forks/boltz/src/boltz/data/filter/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/data/filter/dynamic/__init__.py b/forks/boltz/src/boltz/data/filter/dynamic/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/data/filter/dynamic/date.py b/forks/boltz/src/boltz/data/filter/dynamic/date.py
new file mode 100644
index 00000000..d7a9f08f
--- /dev/null
+++ b/forks/boltz/src/boltz/data/filter/dynamic/date.py
@@ -0,0 +1,76 @@
+from datetime import datetime
+from typing import Literal
+
+from boltz.data.types import Record
+from boltz.data.filter.dynamic.filter import DynamicFilter
+
+
+class DateFilter(DynamicFilter):
+ """A filter that filters complexes based on their date.
+
+ The date can be the deposition, release, or revision date.
+ If the date is not available, the previous date is used.
+
+ If no date is available, the complex is rejected.
+
+ """
+
+ def __init__(
+ self,
+ date: str,
+ ref: Literal["deposited", "revised", "released"],
+ ) -> None:
+ """Initialize the filter.
+
+ Parameters
+ ----------
+ date : str, optional
+ The maximum date of PDB entries to filter
+ ref : Literal["deposited", "revised", "released"]
+ The reference date to use.
+
+ """
+ self.filter_date = datetime.fromisoformat(date)
+ self.ref = ref
+
+ if ref not in ["deposited", "revised", "released"]:
+ msg = (
+ "Invalid reference date. Must be ",
+ "deposited, revised, or released",
+ )
+ raise ValueError(msg)
+
+ def filter(self, record: Record) -> bool:
+ """Filter a record based on its date.
+
+ Parameters
+ ----------
+ record : Record
+ The record to filter.
+
+ Returns
+ -------
+ bool
+ Whether the record should be filtered.
+
+ """
+ structure = record.structure
+
+ if self.ref == "deposited":
+ date = structure.deposited
+ elif self.ref == "released":
+ date = structure.released
+ if not date:
+ date = structure.deposited
+ elif self.ref == "revised":
+ date = structure.revised
+ if not date and structure.released:
+ date = structure.released
+ elif not date:
+ date = structure.deposited
+
+ if date is None or date == "":
+ return False
+
+ date = datetime.fromisoformat(date)
+ return date <= self.filter_date
diff --git a/forks/boltz/src/boltz/data/filter/dynamic/filter.py b/forks/boltz/src/boltz/data/filter/dynamic/filter.py
new file mode 100644
index 00000000..0060922c
--- /dev/null
+++ b/forks/boltz/src/boltz/data/filter/dynamic/filter.py
@@ -0,0 +1,24 @@
+from abc import ABC, abstractmethod
+
+from boltz.data.types import Record
+
+
+class DynamicFilter(ABC):
+ """Base class for data filters."""
+
+ @abstractmethod
+ def filter(self, record: Record) -> bool:
+ """Filter a data record.
+
+ Parameters
+ ----------
+ record : Record
+ The object to consider filtering in / out.
+
+ Returns
+ -------
+ bool
+ True if the data passes the filter, False otherwise.
+
+ """
+ raise NotImplementedError
diff --git a/forks/boltz/src/boltz/data/filter/dynamic/max_residues.py b/forks/boltz/src/boltz/data/filter/dynamic/max_residues.py
new file mode 100644
index 00000000..b8397d40
--- /dev/null
+++ b/forks/boltz/src/boltz/data/filter/dynamic/max_residues.py
@@ -0,0 +1,37 @@
+from boltz.data.types import Record
+from boltz.data.filter.dynamic.filter import DynamicFilter
+
+
+class MaxResiduesFilter(DynamicFilter):
+ """A filter that filters structures based on their size."""
+
+ def __init__(self, min_residues: int = 1, max_residues: int = 500) -> None:
+ """Initialize the filter.
+
+ Parameters
+ ----------
+ min_chains : int
+ The minimum number of chains allowed.
+ max_chains : int
+ The maximum number of chains allowed.
+
+ """
+ self.min_residues = min_residues
+ self.max_residues = max_residues
+
+ def filter(self, record: Record) -> bool:
+ """Filter structures based on their resolution.
+
+ Parameters
+ ----------
+ record : Record
+ The record to filter.
+
+ Returns
+ -------
+ bool
+ Whether the record should be filtered.
+
+ """
+ num_residues = sum(chain.num_residues for chain in record.chains)
+ return num_residues <= self.max_residues and num_residues >= self.min_residues
diff --git a/forks/boltz/src/boltz/data/filter/dynamic/resolution.py b/forks/boltz/src/boltz/data/filter/dynamic/resolution.py
new file mode 100644
index 00000000..8096d6aa
--- /dev/null
+++ b/forks/boltz/src/boltz/data/filter/dynamic/resolution.py
@@ -0,0 +1,34 @@
+from boltz.data.types import Record
+from boltz.data.filter.dynamic.filter import DynamicFilter
+
+
+class ResolutionFilter(DynamicFilter):
+ """A filter that filters complexes based on their resolution."""
+
+ def __init__(self, resolution: float = 9.0) -> None:
+ """Initialize the filter.
+
+ Parameters
+ ----------
+ resolution : float, optional
+ The maximum allowed resolution.
+
+ """
+ self.resolution = resolution
+
+ def filter(self, record: Record) -> bool:
+ """Filter complexes based on their resolution.
+
+ Parameters
+ ----------
+ record : Record
+ The record to filter.
+
+ Returns
+ -------
+ bool
+ Whether the record should be filtered.
+
+ """
+ structure = record.structure
+ return structure.resolution <= self.resolution
diff --git a/forks/boltz/src/boltz/data/filter/dynamic/size.py b/forks/boltz/src/boltz/data/filter/dynamic/size.py
new file mode 100644
index 00000000..8d1094ed
--- /dev/null
+++ b/forks/boltz/src/boltz/data/filter/dynamic/size.py
@@ -0,0 +1,38 @@
+from boltz.data.types import Record
+from boltz.data.filter.dynamic.filter import DynamicFilter
+
+
+class SizeFilter(DynamicFilter):
+ """A filter that filters structures based on their size."""
+
+ def __init__(self, min_chains: int = 1, max_chains: int = 300) -> None:
+ """Initialize the filter.
+
+ Parameters
+ ----------
+ min_chains : int
+ The minimum number of chains allowed.
+ max_chains : int
+ The maximum number of chains allowed.
+
+ """
+ self.min_chains = min_chains
+ self.max_chains = max_chains
+
+ def filter(self, record: Record) -> bool:
+ """Filter structures based on their resolution.
+
+ Parameters
+ ----------
+ record : Record
+ The record to filter.
+
+ Returns
+ -------
+ bool
+ Whether the record should be filtered.
+
+ """
+ num_chains = record.structure.num_chains
+ num_valid = sum(1 for chain in record.chains if chain.valid)
+ return num_chains <= self.max_chains and num_valid >= self.min_chains
diff --git a/forks/boltz/src/boltz/data/filter/dynamic/subset.py b/forks/boltz/src/boltz/data/filter/dynamic/subset.py
new file mode 100644
index 00000000..53e12607
--- /dev/null
+++ b/forks/boltz/src/boltz/data/filter/dynamic/subset.py
@@ -0,0 +1,42 @@
+from pathlib import Path
+
+from boltz.data.types import Record
+from boltz.data.filter.dynamic.filter import DynamicFilter
+
+
+class SubsetFilter(DynamicFilter):
+ """Filter a data record based on a subset of the data."""
+
+ def __init__(self, subset: str, reverse: bool = False) -> None:
+ """Initialize the filter.
+
+ Parameters
+ ----------
+ subset : str
+ The subset of data to consider, one per line.
+
+ """
+ with Path(subset).open("r") as f:
+ subset = f.read().splitlines()
+
+ self.subset = {s.lower() for s in subset}
+ self.reverse = reverse
+
+ def filter(self, record: Record) -> bool:
+ """Filter a data record.
+
+ Parameters
+ ----------
+ record : Record
+ The object to consider filtering in / out.
+
+ Returns
+ -------
+ bool
+ True if the data passes the filter, False otherwise.
+
+ """
+ if self.reverse:
+ return record.id.lower() not in self.subset
+ else: # noqa: RET505
+ return record.id.lower() in self.subset
diff --git a/forks/boltz/src/boltz/data/filter/static/__init__.py b/forks/boltz/src/boltz/data/filter/static/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/data/filter/static/filter.py b/forks/boltz/src/boltz/data/filter/static/filter.py
new file mode 100644
index 00000000..2967e4ea
--- /dev/null
+++ b/forks/boltz/src/boltz/data/filter/static/filter.py
@@ -0,0 +1,26 @@
+from abc import ABC, abstractmethod
+
+import numpy as np
+
+from boltz.data.types import Structure
+
+
+class StaticFilter(ABC):
+ """Base class for structure filters."""
+
+ @abstractmethod
+ def filter(self, structure: Structure) -> np.ndarray:
+ """Filter chains in a structure.
+
+ Parameters
+ ----------
+ structure : Structure
+ The structure to filter chains from.
+
+ Returns
+ -------
+ np.ndarray
+ The chains to keep, as a boolean mask.
+
+ """
+ raise NotImplementedError
diff --git a/forks/boltz/src/boltz/data/filter/static/ligand.py b/forks/boltz/src/boltz/data/filter/static/ligand.py
new file mode 100644
index 00000000..5cceb068
--- /dev/null
+++ b/forks/boltz/src/boltz/data/filter/static/ligand.py
@@ -0,0 +1,37 @@
+import numpy as np
+
+from boltz.data import const
+from boltz.data.filter.static.filter import StaticFilter
+from boltz.data.types import Structure
+
+
+class ExcludedLigands(StaticFilter):
+ """Filter excluded ligands."""
+
+ def filter(self, structure: Structure) -> np.ndarray:
+ """Filter excluded ligands.
+
+ Parameters
+ ----------
+ structure : Structure
+ The structure to filter chains from.
+
+ Returns
+ -------
+ np.ndarray
+ The chains to keep, as a boolean mask.
+
+ """
+ valid = np.ones(len(structure.chains), dtype=bool)
+
+ for i, chain in enumerate(structure.chains):
+ if chain["mol_type"] != const.chain_type_ids["NONPOLYMER"]:
+ continue
+
+ res_start = chain["res_idx"]
+ res_end = res_start + chain["res_num"]
+ residues = structure.residues[res_start:res_end]
+ if any(res["name"] in const.ligand_exclusion for res in residues):
+ valid[i] = 0
+
+ return valid
diff --git a/forks/boltz/src/boltz/data/filter/static/polymer.py b/forks/boltz/src/boltz/data/filter/static/polymer.py
new file mode 100644
index 00000000..e7e12827
--- /dev/null
+++ b/forks/boltz/src/boltz/data/filter/static/polymer.py
@@ -0,0 +1,299 @@
+import itertools
+from dataclasses import dataclass
+
+import numpy as np
+from sklearn.neighbors import KDTree
+
+from boltz.data import const
+from boltz.data.filter.static.filter import StaticFilter
+from boltz.data.types import Structure
+
+
+class MinimumLengthFilter(StaticFilter):
+ """Filter polymers based on their length.
+
+ We use the number of resolved residues when considering
+ the minimum, and the sequence length for the maximum.
+
+ """
+
+ def __init__(self, min_len: int = 4, max_len: int = 5000) -> None:
+ """Initialize the filter.
+
+ Parameters
+ ----------
+ min_len : float, optional
+ The minimum allowed length.
+ max_len : float, optional
+ The maximum allowed length.
+
+ """
+ self._min = min_len
+ self._max = max_len
+
+ def filter(self, structure: Structure) -> np.ndarray:
+ """Filter a chains based on their length.
+
+ Parameters
+ ----------
+ structure : Structure
+ The structure to filter chains from.
+
+ Returns
+ -------
+ np.ndarray
+ The chains to keep, as a boolean mask.
+
+ """
+ valid = np.ones(len(structure.chains), dtype=bool)
+
+ for i, chain in enumerate(structure.chains):
+ if chain["mol_type"] == const.chain_type_ids["NONPOLYMER"]:
+ continue
+
+ res_start = chain["res_idx"]
+ res_end = res_start + chain["res_num"]
+ residues = structure.residues[res_start:res_end]
+ resolved = residues["is_present"].sum()
+
+ if (resolved < self._min) or (resolved > self._max):
+ valid[i] = 0
+
+ return valid
+
+
+class UnknownFilter(StaticFilter):
+ """Filter proteins with all unknown residues."""
+
+ def filter(self, structure: Structure) -> np.ndarray:
+ """Filter proteins with all unknown residues.
+
+ Parameters
+ ----------
+ structure : Structure
+ The structure to filter chains from.
+
+ Returns
+ -------
+ np.ndarray
+ The chains to keep, as a boolean mask.
+
+ """
+ valid = np.ones(len(structure.chains), dtype=bool)
+ unk_toks = {
+ const.chain_type_ids["PROTEIN"]: const.unk_token_ids["PROTEIN"],
+ const.chain_type_ids["DNA"]: const.unk_token_ids["DNA"],
+ const.chain_type_ids["RNA"]: const.unk_token_ids["RNA"],
+ }
+
+ for i, chain in enumerate(structure.chains):
+ if chain["mol_type"] == const.chain_type_ids["NONPOLYMER"]:
+ continue
+
+ res_start = chain["res_idx"]
+ res_end = res_start + chain["res_num"]
+ residues = structure.residues[res_start:res_end]
+
+ unk_id = unk_toks[chain["mol_type"]]
+ if np.all(residues["res_type"] == unk_id):
+ valid[i] = 0
+
+ return valid
+
+
+class ConsecutiveCA(StaticFilter):
+ """Filter proteins with consecutive CA atoms above a threshold."""
+
+ def __init__(self, max_dist: int = 10.0) -> None:
+ """Initialize the filter.
+
+ Parameters
+ ----------
+ max_dist : float, optional
+ The maximum allowed distance.
+
+ """
+ self._max_dist = max_dist
+
+ def filter(self, structure: Structure) -> np.ndarray:
+ """Filter protein if consecutive CA atoms above a threshold.
+
+ Parameters
+ ----------
+ structure : Structure
+ The structure to filter chains from.
+
+ Returns
+ -------
+ np.ndarray
+ The chains to keep, as a boolean mask.
+
+ """
+ valid = np.ones(len(structure.chains), dtype=bool)
+
+ # Remove chain if consecutive CA atoms are above threshold
+ for i, chain in enumerate(structure.chains):
+ # Skip non-protein chains
+ if chain["mol_type"] != const.chain_type_ids["PROTEIN"]:
+ continue
+
+ # Get residues
+ res_start = chain["res_idx"]
+ res_end = res_start + chain["res_num"]
+ residues = structure.residues[res_start:res_end]
+
+ # Get c-alphas
+ ca_ids = residues["atom_center"]
+ ca_atoms = structure.atoms[ca_ids]
+
+ res_valid = residues["is_present"]
+ ca_valid = ca_atoms["is_present"] & res_valid
+ ca_coords = ca_atoms["coords"]
+
+ # Compute distances between consecutive atoms
+ dist = np.linalg.norm(ca_coords[1:] - ca_coords[:-1], axis=1)
+ dist = dist > self._max_dist
+ dist = dist[ca_valid[1:] & ca_valid[:-1]]
+
+ # Remove the chain if any valid pair is above threshold
+ if np.any(dist):
+ valid[i] = 0
+
+ return valid
+
+
+@dataclass(frozen=True)
+class Clash:
+ """A clash between two chains."""
+
+ chain: int
+ other: int
+ num_atoms: int
+ num_clashes: int
+
+
+class ClashingChainsFilter(StaticFilter):
+ """A filter that filters clashing chains.
+
+ Clashing chains are defined as those with >30% of atoms
+ within 1.7 Å of an atom in another chain. If two chains
+ are clashing with each other, the chain with the greater
+ percentage of clashing atoms will be removed. If the same
+ fraction of atoms are clashing, the chain with fewer total
+ atoms is removed. If the chains have the same number of
+ atoms, then the chain with the larger chain id is removed.
+
+ """
+
+ def __init__(self, dist: float = 1.7, freq: float = 0.3) -> None:
+ """Initialize the filter.
+
+ Parameters
+ ----------
+ dist : float, optional
+ The maximum distance for a clash.
+ freq : float, optional
+ The maximum allowed frequency of clashes.
+
+ """
+ self._dist = dist
+ self._freq = freq
+
+ def filter(self, structure: Structure) -> np.ndarray: # noqa: PLR0912, C901
+ """Filter out clashing chains.
+
+ Parameters
+ ----------
+ structure : Structure
+ The structure to filter chains from.
+
+ Returns
+ -------
+ np.ndarray
+ The chains to keep, as a boolean mask.
+
+ """
+ num_chains = len(structure.chains)
+ if num_chains < 2: # noqa: PLR2004
+ return np.ones(num_chains, dtype=bool)
+
+ # Get unique chain pairs
+ pairs = itertools.combinations(range(num_chains), 2)
+
+ # Compute clashes
+ clashes: list[Clash] = []
+ for i, j in pairs:
+ # Get the chains
+ c1 = structure.chains[i]
+ c2 = structure.chains[j]
+
+ # Get the atoms from each chain
+ c1_start = c1["atom_idx"]
+ c2_start = c2["atom_idx"]
+ c1_end = c1_start + c1["atom_num"]
+ c2_end = c2_start + c2["atom_num"]
+
+ atoms1 = structure.atoms[c1_start:c1_end]
+ atoms2 = structure.atoms[c2_start:c2_end]
+ atoms1 = atoms1[atoms1["is_present"]]
+ atoms2 = atoms2[atoms2["is_present"]]
+
+ # Skip if either chain has no atoms
+ if len(atoms1) == 0 or len(atoms2) == 0:
+ continue
+
+ # Compute the number of clashes
+ # Compute the distance matrix
+ tree = KDTree(atoms1["coords"], metric="euclidean")
+ query = tree.query_radius(atoms2["coords"], self._dist)
+
+ c2_clashes = sum(len(neighbors) > 0 for neighbors in query)
+ c1_clashes = len(set(itertools.chain.from_iterable(query)))
+
+ # Save results
+ if (c1_clashes / len(atoms1)) > self._freq:
+ clashes.append(Clash(i, j, len(atoms1), c1_clashes))
+ if (c2_clashes / len(atoms2)) > self._freq:
+ clashes.append(Clash(j, i, len(atoms2), c2_clashes))
+
+ # Compute indices to clash map
+ removed = set()
+ ids_to_clash = {(c.chain, c.other): c for c in clashes}
+
+ # Filter out chains according to ruleset
+ for clash in clashes:
+ # If either is already removed, skip
+ if clash.chain in removed or clash.other in removed:
+ continue
+
+ # Check if the two chains clash with each other
+ other_clash = ids_to_clash.get((clash.other, clash.chain))
+ if other_clash is not None:
+ # Remove the chain with the most clashes
+ clash1_freq = clash.num_clashes / clash.num_atoms
+ clash2_freq = other_clash.num_clashes / other_clash.num_atoms
+ if clash1_freq > clash2_freq:
+ removed.add(clash.chain)
+ elif clash1_freq < clash2_freq:
+ removed.add(clash.other)
+
+ # If same, remove the chain with fewer atoms
+ elif clash.num_atoms < other_clash.num_atoms:
+ removed.add(clash.chain)
+ elif clash.num_atoms > other_clash.num_atoms:
+ removed.add(clash.other)
+
+ # If same, remove the chain with the larger chain id
+ else:
+ removed.add(max(clash.chain, clash.other))
+
+ # Otherwise, just remove the chain directly
+ else:
+ removed.add(clash.chain)
+
+ # Remove the chains
+ valid = np.ones(len(structure.chains), dtype=bool)
+ for i in removed:
+ valid[i] = 0
+
+ return valid
diff --git a/forks/boltz/src/boltz/data/module/__init__.py b/forks/boltz/src/boltz/data/module/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/data/module/inference.py b/forks/boltz/src/boltz/data/module/inference.py
new file mode 100644
index 00000000..b09a6afc
--- /dev/null
+++ b/forks/boltz/src/boltz/data/module/inference.py
@@ -0,0 +1,310 @@
+from pathlib import Path
+from typing import Optional
+
+import numpy as np
+import pytorch_lightning as pl
+import torch
+from torch import Tensor
+from torch.utils.data import DataLoader
+
+from boltz.data import const
+from boltz.data.feature.featurizer import BoltzFeaturizer
+from boltz.data.pad import pad_to_max
+from boltz.data.tokenize.boltz import BoltzTokenizer
+from boltz.data.types import (
+ MSA,
+ Connection,
+ Input,
+ Manifest,
+ Record,
+ ResidueConstraints,
+ Structure,
+)
+
+
+def load_input(
+ record: Record,
+ target_dir: Path,
+ msa_dir: Path,
+ constraints_dir: Optional[Path] = None,
+) -> Input:
+ """Load the given input data.
+
+ Parameters
+ ----------
+ record : Record
+ The record to load.
+ target_dir : Path
+ The path to the data directory.
+ msa_dir : Path
+ The path to msa directory.
+
+ Returns
+ -------
+ Input
+ The loaded input.
+
+ """
+ # Load the structure
+ structure = np.load(target_dir / f"{record.id}.npz")
+ structure = Structure(
+ atoms=structure["atoms"],
+ bonds=structure["bonds"],
+ residues=structure["residues"],
+ chains=structure["chains"],
+ connections=structure["connections"].astype(Connection),
+ interfaces=structure["interfaces"],
+ mask=structure["mask"],
+ )
+
+ msas = {}
+ for chain in record.chains:
+ msa_id = chain.msa_id
+ # Load the MSA for this chain, if any
+ if msa_id != -1:
+ msa = np.load(msa_dir / f"{msa_id}.npz")
+ msas[chain.chain_id] = MSA(**msa)
+
+ residue_constraints = None
+ if constraints_dir is not None:
+ residue_constraints = ResidueConstraints.load(
+ constraints_dir / f"{record.id}.npz"
+ )
+
+ return Input(structure, msas, record, residue_constraints)
+
+
+def collate(data: list[dict[str, Tensor]]) -> dict[str, Tensor]:
+ """Collate the data.
+
+ Parameters
+ ----------
+ data : List[Dict[str, Tensor]]
+ The data to collate.
+
+ Returns
+ -------
+ Dict[str, Tensor]
+ The collated data.
+
+ """
+ # Get the keys
+ keys = data[0].keys()
+
+ # Collate the data
+ collated = {}
+ for key in keys:
+ values = [d[key] for d in data]
+
+ if key not in [
+ "all_coords",
+ "all_resolved_mask",
+ "crop_to_all_atom_map",
+ "chain_symmetries",
+ "amino_acids_symmetries",
+ "ligand_symmetries",
+ "record",
+ ]:
+ # Check if all have the same shape
+ shape = values[0].shape
+ if not all(v.shape == shape for v in values):
+ values, _ = pad_to_max(values, 0)
+ else:
+ values = torch.stack(values, dim=0)
+
+ # Stack the values
+ collated[key] = values
+
+ return collated
+
+
+class PredictionDataset(torch.utils.data.Dataset):
+ """Base iterable dataset."""
+
+ def __init__(
+ self,
+ manifest: Manifest,
+ target_dir: Path,
+ msa_dir: Path,
+ constraints_dir: Optional[Path] = None,
+ ) -> None:
+ """Initialize the training dataset.
+
+ Parameters
+ ----------
+ manifest : Manifest
+ The manifest to load data from.
+ target_dir : Path
+ The path to the target directory.
+ msa_dir : Path
+ The path to the msa directory.
+
+ """
+ super().__init__()
+ self.manifest = manifest
+ self.target_dir = target_dir
+ self.msa_dir = msa_dir
+ self.constraints_dir = constraints_dir
+ self.tokenizer = BoltzTokenizer()
+ self.featurizer = BoltzFeaturizer()
+
+ def __getitem__(self, idx: int) -> dict:
+ """Get an item from the dataset.
+
+ Returns
+ -------
+ Dict[str, Tensor]
+ The sampled data features.
+
+ """
+ # Get a sample from the dataset
+ record = self.manifest.records[idx]
+
+ # Get the structure
+ try:
+ input_data = load_input(
+ record,
+ self.target_dir,
+ self.msa_dir,
+ self.constraints_dir,
+ )
+ except Exception as e: # noqa: BLE001
+ print(f"Failed to load input for {record.id} with error {e}. Skipping.") # noqa: T201
+ return self.__getitem__(0)
+
+ # Tokenize structure
+ try:
+ tokenized = self.tokenizer.tokenize(input_data)
+ except Exception as e: # noqa: BLE001
+ print(f"Tokenizer failed on {record.id} with error {e}. Skipping.") # noqa: T201
+ return self.__getitem__(0)
+
+ # Inference specific options
+ options = record.inference_options
+ if options is None or len(options.pocket_constraints) == 0:
+ binder, pocket = None, None
+ else:
+ binder, pocket = (
+ options.pocket_constraints[0][0],
+ options.pocket_constraints[0][1],
+ )
+
+ # Compute features
+ try:
+ features = self.featurizer.process(
+ tokenized,
+ training=False,
+ max_atoms=None,
+ max_tokens=None,
+ max_seqs=const.max_msa_seqs,
+ pad_to_max_seqs=False,
+ symmetries={},
+ compute_symmetries=False,
+ inference_binder=binder,
+ inference_pocket=pocket,
+ compute_constraint_features=True,
+ )
+ except Exception as e: # noqa: BLE001
+ print(f"Featurizer failed on {record.id} with error {e}. Skipping.") # noqa: T201
+ return self.__getitem__(0)
+
+ features["record"] = record
+ return features
+
+ def __len__(self) -> int:
+ """Get the length of the dataset.
+
+ Returns
+ -------
+ int
+ The length of the dataset.
+
+ """
+ return len(self.manifest.records)
+
+
+class BoltzInferenceDataModule(pl.LightningDataModule):
+ """DataModule for Boltz inference."""
+
+ def __init__(
+ self,
+ manifest: Manifest,
+ target_dir: Path,
+ msa_dir: Path,
+ num_workers: int,
+ constraints_dir: Optional[Path] = None,
+ ) -> None:
+ """Initialize the DataModule.
+
+ Parameters
+ ----------
+ config : DataConfig
+ The data configuration.
+
+ """
+ super().__init__()
+ self.num_workers = num_workers
+ self.manifest = manifest
+ self.target_dir = target_dir
+ self.msa_dir = msa_dir
+ self.constraints_dir = constraints_dir
+
+ def predict_dataloader(self) -> DataLoader:
+ """Get the training dataloader.
+
+ Returns
+ -------
+ DataLoader
+ The training dataloader.
+
+ """
+ dataset = PredictionDataset(
+ manifest=self.manifest,
+ target_dir=self.target_dir,
+ msa_dir=self.msa_dir,
+ constraints_dir=self.constraints_dir,
+ )
+ return DataLoader(
+ dataset,
+ batch_size=1,
+ num_workers=self.num_workers,
+ pin_memory=True,
+ shuffle=False,
+ collate_fn=collate,
+ )
+
+ def transfer_batch_to_device(
+ self,
+ batch: dict,
+ device: torch.device,
+ dataloader_idx: int, # noqa: ARG002
+ ) -> dict:
+ """Transfer a batch to the given device.
+
+ Parameters
+ ----------
+ batch : Dict
+ The batch to transfer.
+ device : torch.device
+ The device to transfer to.
+ dataloader_idx : int
+ The dataloader index.
+
+ Returns
+ -------
+ np.Any
+ The transferred batch.
+
+ """
+ for key in batch:
+ if key not in [
+ "all_coords",
+ "all_resolved_mask",
+ "crop_to_all_atom_map",
+ "chain_symmetries",
+ "amino_acids_symmetries",
+ "ligand_symmetries",
+ "record",
+ ]:
+ batch[key] = batch[key].to(device)
+ return batch
diff --git a/forks/boltz/src/boltz/data/module/inferencev2.py b/forks/boltz/src/boltz/data/module/inferencev2.py
new file mode 100644
index 00000000..590297d2
--- /dev/null
+++ b/forks/boltz/src/boltz/data/module/inferencev2.py
@@ -0,0 +1,433 @@
+import pickle
+from pathlib import Path
+from typing import Optional
+
+import numpy as np
+import pytorch_lightning as pl
+import torch
+from torch import Tensor
+from torch.utils.data import DataLoader
+
+from boltz.data import const
+from boltz.data.crop.affinity import AffinityCropper
+from boltz.data.feature.featurizerv2 import Boltz2Featurizer
+from boltz.data.mol import load_canonicals, load_molecules
+from boltz.data.pad import pad_to_max
+from boltz.data.tokenize.boltz2 import Boltz2Tokenizer
+from boltz.data.types import (
+ MSA,
+ Input,
+ Manifest,
+ Record,
+ ResidueConstraints,
+ StructureV2,
+)
+
+
+def load_input(
+ record: Record,
+ target_dir: Path,
+ msa_dir: Path,
+ constraints_dir: Optional[Path] = None,
+ template_dir: Optional[Path] = None,
+ extra_mols_dir: Optional[Path] = None,
+ affinity: bool = False,
+) -> Input:
+ """Load the given input data.
+
+ Parameters
+ ----------
+ record : Record
+ The record to load.
+ target_dir : Path
+ The path to the data directory.
+ msa_dir : Path
+ The path to msa directory.
+ constraints_dir : Optional[Path]
+ The path to the constraints directory.
+ template_dir : Optional[Path]
+ The path to the template directory.
+ extra_mols_dir : Optional[Path]
+ The path to the extra molecules directory.
+ affinity : bool
+ Whether to load the affinity data.
+
+ Returns
+ -------
+ Input
+ The loaded input.
+
+ """
+ # Load the structure
+ if affinity:
+ structure = StructureV2.load(
+ target_dir / record.id / f"pre_affinity_{record.id}.npz"
+ )
+ else:
+ structure = StructureV2.load(target_dir / f"{record.id}.npz")
+
+ msas = {}
+ for chain in record.chains:
+ msa_id = chain.msa_id
+ # Load the MSA for this chain, if any
+ if msa_id != -1:
+ msa = MSA.load(msa_dir / f"{msa_id}.npz")
+ msas[chain.chain_id] = msa
+
+ # Load templates
+ templates = None
+ if record.templates and template_dir is not None:
+ templates = {}
+ for template_info in record.templates:
+ template_id = template_info.name
+ template_path = template_dir / f"{record.id}_{template_id}.npz"
+ template = StructureV2.load(template_path)
+ templates[template_id] = template
+
+ # Load residue constraints
+ residue_constraints = None
+ if constraints_dir is not None:
+ residue_constraints = ResidueConstraints.load(
+ constraints_dir / f"{record.id}.npz"
+ )
+
+ # Load extra molecules
+ extra_mols = {}
+ if extra_mols_dir is not None:
+ extra_mol_path = extra_mols_dir / f"{record.id}.pkl"
+ if extra_mol_path.exists():
+ with extra_mol_path.open("rb") as f:
+ extra_mols = pickle.load(f) # noqa: S301
+
+ return Input(
+ structure,
+ msas,
+ record=record,
+ residue_constraints=residue_constraints,
+ templates=templates,
+ extra_mols=extra_mols,
+ )
+
+
+def collate(data: list[dict[str, Tensor]]) -> dict[str, Tensor]:
+ """Collate the data.
+
+ Parameters
+ ----------
+ data : List[Dict[str, Tensor]]
+ The data to collate.
+
+ Returns
+ -------
+ Dict[str, Tensor]
+ The collated data.
+
+ """
+ # Get the keys
+ keys = data[0].keys()
+
+ # Collate the data
+ collated = {}
+ for key in keys:
+ values = [d[key] for d in data]
+
+ if key not in [
+ "all_coords",
+ "all_resolved_mask",
+ "crop_to_all_atom_map",
+ "chain_symmetries",
+ "amino_acids_symmetries",
+ "ligand_symmetries",
+ "record",
+ "affinity_mw",
+ ]:
+ # Check if all have the same shape
+ shape = values[0].shape
+ if not all(v.shape == shape for v in values):
+ values, _ = pad_to_max(values, 0)
+ else:
+ values = torch.stack(values, dim=0)
+
+ # Stack the values
+ collated[key] = values
+
+ return collated
+
+
+class PredictionDataset(torch.utils.data.Dataset):
+ """Base iterable dataset."""
+
+ def __init__(
+ self,
+ manifest: Manifest,
+ target_dir: Path,
+ msa_dir: Path,
+ mol_dir: Path,
+ constraints_dir: Optional[Path] = None,
+ template_dir: Optional[Path] = None,
+ extra_mols_dir: Optional[Path] = None,
+ override_method: Optional[str] = None,
+ affinity: bool = False,
+ ) -> None:
+ """Initialize the training dataset.
+
+ Parameters
+ ----------
+ manifest : Manifest
+ The manifest to load data from.
+ target_dir : Path
+ The path to the target directory.
+ msa_dir : Path
+ The path to the msa directory.
+ mol_dir : Path
+ The path to the moldir.
+ constraints_dir : Optional[Path]
+ The path to the constraints directory.
+ template_dir : Optional[Path]
+ The path to the template directory.
+
+ """
+ super().__init__()
+ self.manifest = manifest
+ self.target_dir = target_dir
+ self.msa_dir = msa_dir
+ self.mol_dir = mol_dir
+ self.constraints_dir = constraints_dir
+ self.template_dir = template_dir
+ self.tokenizer = Boltz2Tokenizer()
+ self.featurizer = Boltz2Featurizer()
+ self.canonicals = load_canonicals(self.mol_dir)
+ self.extra_mols_dir = extra_mols_dir
+ self.override_method = override_method
+ self.affinity = affinity
+ if self.affinity:
+ self.cropper = AffinityCropper()
+
+ def __getitem__(self, idx: int) -> dict:
+ """Get an item from the dataset.
+
+ Returns
+ -------
+ Dict[str, Tensor]
+ The sampled data features.
+
+ """
+ # Get record
+ record = self.manifest.records[idx]
+
+ # Finalize input data
+ input_data = load_input(
+ record=record,
+ target_dir=self.target_dir,
+ msa_dir=self.msa_dir,
+ constraints_dir=self.constraints_dir,
+ template_dir=self.template_dir,
+ extra_mols_dir=self.extra_mols_dir,
+ affinity=self.affinity,
+ )
+
+ # Tokenize structure
+ try:
+ tokenized = self.tokenizer.tokenize(input_data)
+ except Exception as e: # noqa: BLE001
+ print( # noqa: T201
+ f"Tokenizer failed on {record.id} with error {e}. Skipping."
+ )
+ return self.__getitem__(0)
+
+ if self.affinity:
+ try:
+ tokenized = self.cropper.crop(
+ tokenized,
+ max_tokens=256,
+ max_atoms=2048,
+ )
+ except Exception as e: # noqa: BLE001
+ print(f"Cropper failed on {record.id} with error {e}. Skipping.") # noqa: T201
+ return self.__getitem__(0)
+
+ # Load conformers
+ try:
+ molecules = {}
+ molecules.update(self.canonicals)
+ molecules.update(input_data.extra_mols)
+ mol_names = set(tokenized.tokens["res_name"].tolist())
+ mol_names = mol_names - set(molecules.keys())
+ molecules.update(load_molecules(self.mol_dir, mol_names))
+ except Exception as e: # noqa: BLE001
+ print(f"Molecule loading failed for {record.id} with error {e}. Skipping.")
+ return self.__getitem__(0)
+
+ # Inference specific options
+ options = record.inference_options
+ if options is None:
+ pocket_constraints, contact_constraints = None, None
+ else:
+ pocket_constraints, contact_constraints = (
+ options.pocket_constraints,
+ options.contact_constraints,
+ )
+
+ # Get random seed
+ seed = 42
+ random = np.random.default_rng(seed)
+
+ # Compute features
+ try:
+ features = self.featurizer.process(
+ tokenized,
+ molecules=molecules,
+ random=random,
+ training=False,
+ max_atoms=None,
+ max_tokens=None,
+ max_seqs=const.max_msa_seqs,
+ pad_to_max_seqs=False,
+ single_sequence_prop=0.0,
+ compute_frames=True,
+ inference_pocket_constraints=pocket_constraints,
+ inference_contact_constraints=contact_constraints,
+ compute_constraint_features=True,
+ override_method=self.override_method,
+ compute_affinity=self.affinity,
+ )
+ except Exception as e: # noqa: BLE001
+ import traceback
+
+ traceback.print_exc()
+ print(f"Featurizer failed on {record.id} with error {e}. Skipping.") # noqa: T201
+ return self.__getitem__(0)
+
+ # Add record
+ features["record"] = record
+ return features
+
+ def __len__(self) -> int:
+ """Get the length of the dataset.
+
+ Returns
+ -------
+ int
+ The length of the dataset.
+
+ """
+ return len(self.manifest.records)
+
+
+class Boltz2InferenceDataModule(pl.LightningDataModule):
+ """DataModule for Boltz2 inference."""
+
+ def __init__(
+ self,
+ manifest: Manifest,
+ target_dir: Path,
+ msa_dir: Path,
+ mol_dir: Path,
+ num_workers: int,
+ constraints_dir: Optional[Path] = None,
+ template_dir: Optional[Path] = None,
+ extra_mols_dir: Optional[Path] = None,
+ override_method: Optional[str] = None,
+ affinity: bool = False,
+ ) -> None:
+ """Initialize the DataModule.
+
+ Parameters
+ ----------
+ manifest : Manifest
+ The manifest to load data from.
+ target_dir : Path
+ The path to the target directory.
+ msa_dir : Path
+ The path to the msa directory.
+ mol_dir : Path
+ The path to the moldir.
+ num_workers : int
+ The number of workers to use.
+ constraints_dir : Optional[Path]
+ The path to the constraints directory.
+ template_dir : Optional[Path]
+ The path to the template directory.
+ extra_mols_dir : Optional[Path]
+ The path to the extra molecules directory.
+ override_method : Optional[str]
+ The method to override.
+
+ """
+ super().__init__()
+ self.num_workers = num_workers
+ self.manifest = manifest
+ self.target_dir = target_dir
+ self.msa_dir = msa_dir
+ self.mol_dir = mol_dir
+ self.constraints_dir = constraints_dir
+ self.template_dir = template_dir
+ self.extra_mols_dir = extra_mols_dir
+ self.override_method = override_method
+ self.affinity = affinity
+
+ def predict_dataloader(self) -> DataLoader:
+ """Get the training dataloader.
+
+ Returns
+ -------
+ DataLoader
+ The training dataloader.
+
+ """
+ dataset = PredictionDataset(
+ manifest=self.manifest,
+ target_dir=self.target_dir,
+ msa_dir=self.msa_dir,
+ mol_dir=self.mol_dir,
+ constraints_dir=self.constraints_dir,
+ template_dir=self.template_dir,
+ extra_mols_dir=self.extra_mols_dir,
+ override_method=self.override_method,
+ affinity=self.affinity,
+ )
+ return DataLoader(
+ dataset,
+ batch_size=1,
+ num_workers=self.num_workers,
+ pin_memory=True,
+ shuffle=False,
+ collate_fn=collate,
+ )
+
+ def transfer_batch_to_device(
+ self,
+ batch: dict,
+ device: torch.device,
+ dataloader_idx: int, # noqa: ARG002
+ ) -> dict:
+ """Transfer a batch to the given device.
+
+ Parameters
+ ----------
+ batch : Dict
+ The batch to transfer.
+ device : torch.device
+ The device to transfer to.
+ dataloader_idx : int
+ The dataloader index.
+
+ Returns
+ -------
+ np.Any
+ The transferred batch.
+
+ """
+ for key in batch:
+ if key not in [
+ "all_coords",
+ "all_resolved_mask",
+ "crop_to_all_atom_map",
+ "chain_symmetries",
+ "amino_acids_symmetries",
+ "ligand_symmetries",
+ "record",
+ "affinity_mw",
+ ]:
+ batch[key] = batch[key].to(device)
+ return batch
diff --git a/forks/boltz/src/boltz/data/module/training.py b/forks/boltz/src/boltz/data/module/training.py
new file mode 100644
index 00000000..36583b6c
--- /dev/null
+++ b/forks/boltz/src/boltz/data/module/training.py
@@ -0,0 +1,687 @@
+from dataclasses import dataclass
+from pathlib import Path
+from typing import Optional
+
+import numpy as np
+import pytorch_lightning as pl
+import torch
+from torch import Tensor
+from torch.utils.data import DataLoader
+
+from boltz.data.crop.cropper import Cropper
+from boltz.data.feature.featurizer import BoltzFeaturizer
+from boltz.data.feature.symmetry import get_symmetries
+from boltz.data.filter.dynamic.filter import DynamicFilter
+from boltz.data.pad import pad_to_max
+from boltz.data.sample.sampler import Sample, Sampler
+from boltz.data.tokenize.tokenizer import Tokenizer
+from boltz.data.types import MSA, Connection, Input, Manifest, Record, Structure
+
+
+@dataclass
+class DatasetConfig:
+ """Dataset configuration."""
+
+ target_dir: str
+ msa_dir: str
+ prob: float
+ sampler: Sampler
+ cropper: Cropper
+ filters: Optional[list] = None
+ split: Optional[str] = None
+ manifest_path: Optional[str] = None
+
+
+@dataclass
+class DataConfig:
+ """Data configuration."""
+
+ datasets: list[DatasetConfig]
+ filters: list[DynamicFilter]
+ featurizer: BoltzFeaturizer
+ tokenizer: Tokenizer
+ max_atoms: int
+ max_tokens: int
+ max_seqs: int
+ samples_per_epoch: int
+ batch_size: int
+ num_workers: int
+ random_seed: int
+ pin_memory: bool
+ symmetries: str
+ atoms_per_window_queries: int
+ min_dist: float
+ max_dist: float
+ num_bins: int
+ overfit: Optional[int] = None
+ pad_to_max_tokens: bool = False
+ pad_to_max_atoms: bool = False
+ pad_to_max_seqs: bool = False
+ crop_validation: bool = False
+ return_train_symmetries: bool = False
+ return_val_symmetries: bool = True
+ train_binder_pocket_conditioned_prop: float = 0.0
+ val_binder_pocket_conditioned_prop: float = 0.0
+ binder_pocket_cutoff: float = 6.0
+ binder_pocket_sampling_geometric_p: float = 0.0
+ val_batch_size: int = 1
+ compute_constraint_features: bool = False
+
+
+@dataclass
+class Dataset:
+ """Data holder."""
+
+ target_dir: Path
+ msa_dir: Path
+ manifest: Manifest
+ prob: float
+ sampler: Sampler
+ cropper: Cropper
+ tokenizer: Tokenizer
+ featurizer: BoltzFeaturizer
+
+
+def load_input(record: Record, target_dir: Path, msa_dir: Path) -> Input:
+ """Load the given input data.
+
+ Parameters
+ ----------
+ record : Record
+ The record to load.
+ target_dir : Path
+ The path to the data directory.
+ msa_dir : Path
+ The path to msa directory.
+
+ Returns
+ -------
+ Input
+ The loaded input.
+
+ """
+ # Load the structure
+ structure = np.load(target_dir / "structures" / f"{record.id}.npz")
+
+ # In order to add cyclic_period to chains if it does not exist
+ # Extract the chains array
+ chains = structure["chains"]
+ # Check if the field exists
+ if "cyclic_period" not in chains.dtype.names:
+ # Create a new dtype with the additional field
+ new_dtype = chains.dtype.descr + [("cyclic_period", "i4")]
+ # Create a new array with the new dtype
+ new_chains = np.empty(chains.shape, dtype=new_dtype)
+ # Copy over existing fields
+ for name in chains.dtype.names:
+ new_chains[name] = chains[name]
+ # Set the new field to 0
+ new_chains["cyclic_period"] = 0
+ # Replace old chains array with new one
+ chains = new_chains
+
+ structure = Structure(
+ atoms=structure["atoms"],
+ bonds=structure["bonds"],
+ residues=structure["residues"],
+ chains=chains, # chains var accounting for missing cyclic_period
+ connections=structure["connections"].astype(Connection),
+ interfaces=structure["interfaces"],
+ mask=structure["mask"],
+ )
+
+ msas = {}
+ for chain in record.chains:
+ msa_id = chain.msa_id
+ # Load the MSA for this chain, if any
+ if msa_id != -1 and msa_id != "":
+ msa = np.load(msa_dir / f"{msa_id}.npz")
+ msas[chain.chain_id] = MSA(**msa)
+
+ return Input(structure, msas)
+
+
+def collate(data: list[dict[str, Tensor]]) -> dict[str, Tensor]:
+ """Collate the data.
+
+ Parameters
+ ----------
+ data : list[dict[str, Tensor]]
+ The data to collate.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The collated data.
+
+ """
+ # Get the keys
+ keys = data[0].keys()
+
+ # Collate the data
+ collated = {}
+ for key in keys:
+ values = [d[key] for d in data]
+
+ if key not in [
+ "all_coords",
+ "all_resolved_mask",
+ "crop_to_all_atom_map",
+ "chain_symmetries",
+ "amino_acids_symmetries",
+ "ligand_symmetries",
+ ]:
+ # Check if all have the same shape
+ shape = values[0].shape
+ if not all(v.shape == shape for v in values):
+ values, _ = pad_to_max(values, 0)
+ else:
+ values = torch.stack(values, dim=0)
+
+ # Stack the values
+ collated[key] = values
+
+ return collated
+
+
+class TrainingDataset(torch.utils.data.Dataset):
+ """Base iterable dataset."""
+
+ def __init__(
+ self,
+ datasets: list[Dataset],
+ samples_per_epoch: int,
+ symmetries: dict,
+ max_atoms: int,
+ max_tokens: int,
+ max_seqs: int,
+ pad_to_max_atoms: bool = False,
+ pad_to_max_tokens: bool = False,
+ pad_to_max_seqs: bool = False,
+ atoms_per_window_queries: int = 32,
+ min_dist: float = 2.0,
+ max_dist: float = 22.0,
+ num_bins: int = 64,
+ overfit: Optional[int] = None,
+ binder_pocket_conditioned_prop: Optional[float] = 0.0,
+ binder_pocket_cutoff: Optional[float] = 6.0,
+ binder_pocket_sampling_geometric_p: Optional[float] = 0.0,
+ return_symmetries: Optional[bool] = False,
+ compute_constraint_features: bool = False,
+ ) -> None:
+ """Initialize the training dataset."""
+ super().__init__()
+ self.datasets = datasets
+ self.probs = [d.prob for d in datasets]
+ self.samples_per_epoch = samples_per_epoch
+ self.symmetries = symmetries
+ self.max_tokens = max_tokens
+ self.max_seqs = max_seqs
+ self.max_atoms = max_atoms
+ self.pad_to_max_tokens = pad_to_max_tokens
+ self.pad_to_max_atoms = pad_to_max_atoms
+ self.pad_to_max_seqs = pad_to_max_seqs
+ self.atoms_per_window_queries = atoms_per_window_queries
+ self.min_dist = min_dist
+ self.max_dist = max_dist
+ self.num_bins = num_bins
+ self.binder_pocket_conditioned_prop = binder_pocket_conditioned_prop
+ self.binder_pocket_cutoff = binder_pocket_cutoff
+ self.binder_pocket_sampling_geometric_p = binder_pocket_sampling_geometric_p
+ self.return_symmetries = return_symmetries
+ self.compute_constraint_features = compute_constraint_features
+ self.samples = []
+ for dataset in datasets:
+ records = dataset.manifest.records
+ if overfit is not None:
+ records = records[:overfit]
+ iterator = dataset.sampler.sample(records, np.random)
+ self.samples.append(iterator)
+
+ def __getitem__(self, idx: int) -> dict[str, Tensor]:
+ """Get an item from the dataset.
+
+ Parameters
+ ----------
+ idx : int
+ The data index.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The sampled data features.
+
+ """
+ # Pick a random dataset
+ dataset_idx = np.random.choice(
+ len(self.datasets),
+ p=self.probs,
+ )
+ dataset = self.datasets[dataset_idx]
+
+ # Get a sample from the dataset
+ sample: Sample = next(self.samples[dataset_idx])
+
+ # Get the structure
+ try:
+ input_data = load_input(sample.record, dataset.target_dir, dataset.msa_dir)
+ except Exception as e:
+ print(
+ f"Failed to load input for {sample.record.id} with error {e}. Skipping."
+ )
+ return self.__getitem__(idx)
+
+ # Tokenize structure
+ try:
+ tokenized = dataset.tokenizer.tokenize(input_data)
+ except Exception as e:
+ print(f"Tokenizer failed on {sample.record.id} with error {e}. Skipping.")
+ return self.__getitem__(idx)
+
+ # Compute crop
+ try:
+ if self.max_tokens is not None:
+ tokenized = dataset.cropper.crop(
+ tokenized,
+ max_atoms=self.max_atoms,
+ max_tokens=self.max_tokens,
+ random=np.random,
+ chain_id=sample.chain_id,
+ interface_id=sample.interface_id,
+ )
+ except Exception as e:
+ print(f"Cropper failed on {sample.record.id} with error {e}. Skipping.")
+ return self.__getitem__(idx)
+
+ # Check if there are tokens
+ if len(tokenized.tokens) == 0:
+ msg = "No tokens in cropped structure."
+ raise ValueError(msg)
+
+ # Compute features
+ try:
+ features = dataset.featurizer.process(
+ tokenized,
+ training=True,
+ max_atoms=self.max_atoms if self.pad_to_max_atoms else None,
+ max_tokens=self.max_tokens if self.pad_to_max_tokens else None,
+ max_seqs=self.max_seqs,
+ pad_to_max_seqs=self.pad_to_max_seqs,
+ symmetries=self.symmetries,
+ atoms_per_window_queries=self.atoms_per_window_queries,
+ min_dist=self.min_dist,
+ max_dist=self.max_dist,
+ num_bins=self.num_bins,
+ compute_symmetries=self.return_symmetries,
+ binder_pocket_conditioned_prop=self.binder_pocket_conditioned_prop,
+ binder_pocket_cutoff=self.binder_pocket_cutoff,
+ binder_pocket_sampling_geometric_p=self.binder_pocket_sampling_geometric_p,
+ compute_constraint_features=self.compute_constraint_features,
+ )
+ except Exception as e:
+ print(f"Featurizer failed on {sample.record.id} with error {e}. Skipping.")
+ return self.__getitem__(idx)
+
+ return features
+
+ def __len__(self) -> int:
+ """Get the length of the dataset.
+
+ Returns
+ -------
+ int
+ The length of the dataset.
+
+ """
+ return self.samples_per_epoch
+
+
+class ValidationDataset(torch.utils.data.Dataset):
+ """Base iterable dataset."""
+
+ def __init__(
+ self,
+ datasets: list[Dataset],
+ seed: int,
+ symmetries: dict,
+ max_atoms: Optional[int] = None,
+ max_tokens: Optional[int] = None,
+ max_seqs: Optional[int] = None,
+ pad_to_max_atoms: bool = False,
+ pad_to_max_tokens: bool = False,
+ pad_to_max_seqs: bool = False,
+ atoms_per_window_queries: int = 32,
+ min_dist: float = 2.0,
+ max_dist: float = 22.0,
+ num_bins: int = 64,
+ overfit: Optional[int] = None,
+ crop_validation: bool = False,
+ return_symmetries: Optional[bool] = False,
+ binder_pocket_conditioned_prop: Optional[float] = 0.0,
+ binder_pocket_cutoff: Optional[float] = 6.0,
+ compute_constraint_features: bool = False,
+ ) -> None:
+ """Initialize the validation dataset."""
+ super().__init__()
+ self.datasets = datasets
+ self.max_atoms = max_atoms
+ self.max_tokens = max_tokens
+ self.max_seqs = max_seqs
+ self.seed = seed
+ self.symmetries = symmetries
+ self.random = np.random if overfit else np.random.RandomState(self.seed)
+ self.pad_to_max_tokens = pad_to_max_tokens
+ self.pad_to_max_atoms = pad_to_max_atoms
+ self.pad_to_max_seqs = pad_to_max_seqs
+ self.overfit = overfit
+ self.crop_validation = crop_validation
+ self.atoms_per_window_queries = atoms_per_window_queries
+ self.min_dist = min_dist
+ self.max_dist = max_dist
+ self.num_bins = num_bins
+ self.return_symmetries = return_symmetries
+ self.binder_pocket_conditioned_prop = binder_pocket_conditioned_prop
+ self.binder_pocket_cutoff = binder_pocket_cutoff
+ self.compute_constraint_features = compute_constraint_features
+
+ def __getitem__(self, idx: int) -> dict[str, Tensor]:
+ """Get an item from the dataset.
+
+ Parameters
+ ----------
+ idx : int
+ The data index.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The sampled data features.
+
+ """
+ # Pick dataset based on idx
+ for dataset in self.datasets:
+ size = len(dataset.manifest.records)
+ if self.overfit is not None:
+ size = min(size, self.overfit)
+ if idx < size:
+ break
+ idx -= size
+
+ # Get a sample from the dataset
+ record = dataset.manifest.records[idx]
+
+ # Get the structure
+ try:
+ input_data = load_input(record, dataset.target_dir, dataset.msa_dir)
+ except Exception as e:
+ print(f"Failed to load input for {record.id} with error {e}. Skipping.")
+ return self.__getitem__(0)
+
+ # Tokenize structure
+ try:
+ tokenized = dataset.tokenizer.tokenize(input_data)
+ except Exception as e:
+ print(f"Tokenizer failed on {record.id} with error {e}. Skipping.")
+ return self.__getitem__(0)
+
+ # Compute crop
+ try:
+ if self.crop_validation and (self.max_tokens is not None):
+ tokenized = dataset.cropper.crop(
+ tokenized,
+ max_tokens=self.max_tokens,
+ random=self.random,
+ max_atoms=self.max_atoms,
+ )
+ except Exception as e:
+ print(f"Cropper failed on {record.id} with error {e}. Skipping.")
+ return self.__getitem__(0)
+
+ # Check if there are tokens
+ if len(tokenized.tokens) == 0:
+ msg = "No tokens in cropped structure."
+ raise ValueError(msg)
+
+ # Compute features
+ try:
+ pad_atoms = self.crop_validation and self.pad_to_max_atoms
+ pad_tokens = self.crop_validation and self.pad_to_max_tokens
+
+ features = dataset.featurizer.process(
+ tokenized,
+ training=False,
+ max_atoms=self.max_atoms if pad_atoms else None,
+ max_tokens=self.max_tokens if pad_tokens else None,
+ max_seqs=self.max_seqs,
+ pad_to_max_seqs=self.pad_to_max_seqs,
+ symmetries=self.symmetries,
+ atoms_per_window_queries=self.atoms_per_window_queries,
+ min_dist=self.min_dist,
+ max_dist=self.max_dist,
+ num_bins=self.num_bins,
+ compute_symmetries=self.return_symmetries,
+ binder_pocket_conditioned_prop=self.binder_pocket_conditioned_prop,
+ binder_pocket_cutoff=self.binder_pocket_cutoff,
+ binder_pocket_sampling_geometric_p=1.0, # this will only sample a single pocket token
+ only_ligand_binder_pocket=True,
+ compute_constraint_features=self.compute_constraint_features,
+ )
+ except Exception as e:
+ print(f"Featurizer failed on {record.id} with error {e}. Skipping.")
+ return self.__getitem__(0)
+
+ return features
+
+ def __len__(self) -> int:
+ """Get the length of the dataset.
+
+ Returns
+ -------
+ int
+ The length of the dataset.
+
+ """
+ if self.overfit is not None:
+ length = sum(len(d.manifest.records[: self.overfit]) for d in self.datasets)
+ else:
+ length = sum(len(d.manifest.records) for d in self.datasets)
+
+ return length
+
+
+class BoltzTrainingDataModule(pl.LightningDataModule):
+ """DataModule for boltz."""
+
+ def __init__(self, cfg: DataConfig) -> None:
+ """Initialize the DataModule.
+
+ Parameters
+ ----------
+ config : DataConfig
+ The data configuration.
+
+ """
+ super().__init__()
+ self.cfg = cfg
+
+ assert self.cfg.val_batch_size == 1, "Validation only works with batch size=1."
+
+ # Load symmetries
+ symmetries = get_symmetries(cfg.symmetries)
+
+ # Load datasets
+ train: list[Dataset] = []
+ val: list[Dataset] = []
+
+ for data_config in cfg.datasets:
+ # Set target_dir
+ target_dir = Path(data_config.target_dir)
+ msa_dir = Path(data_config.msa_dir)
+
+ # Load manifest
+ if data_config.manifest_path is not None:
+ path = Path(data_config.manifest_path)
+ else:
+ path = target_dir / "manifest.json"
+ manifest: Manifest = Manifest.load(path)
+
+ # Split records if given
+ if data_config.split is not None:
+ with Path(data_config.split).open("r") as f:
+ split = {x.lower() for x in f.read().splitlines()}
+
+ train_records = []
+ val_records = []
+ for record in manifest.records:
+ if record.id.lower() in split:
+ val_records.append(record)
+ else:
+ train_records.append(record)
+ else:
+ train_records = manifest.records
+ val_records = []
+
+ # Filter training records
+ train_records = [
+ record
+ for record in train_records
+ if all(f.filter(record) for f in cfg.filters)
+ ]
+ # Filter training records
+ if data_config.filters is not None:
+ train_records = [
+ record
+ for record in train_records
+ if all(f.filter(record) for f in data_config.filters)
+ ]
+
+ # Create train dataset
+ train_manifest = Manifest(train_records)
+ train.append(
+ Dataset(
+ target_dir,
+ msa_dir,
+ train_manifest,
+ data_config.prob,
+ data_config.sampler,
+ data_config.cropper,
+ cfg.tokenizer,
+ cfg.featurizer,
+ )
+ )
+
+ # Create validation dataset
+ if val_records:
+ val_manifest = Manifest(val_records)
+ val.append(
+ Dataset(
+ target_dir,
+ msa_dir,
+ val_manifest,
+ data_config.prob,
+ data_config.sampler,
+ data_config.cropper,
+ cfg.tokenizer,
+ cfg.featurizer,
+ )
+ )
+
+ # Print dataset sizes
+ for dataset in train:
+ dataset: Dataset
+ print(f"Training dataset size: {len(dataset.manifest.records)}")
+
+ for dataset in val:
+ dataset: Dataset
+ print(f"Validation dataset size: {len(dataset.manifest.records)}")
+
+ # Create wrapper datasets
+ self._train_set = TrainingDataset(
+ datasets=train,
+ samples_per_epoch=cfg.samples_per_epoch,
+ max_atoms=cfg.max_atoms,
+ max_tokens=cfg.max_tokens,
+ max_seqs=cfg.max_seqs,
+ pad_to_max_atoms=cfg.pad_to_max_atoms,
+ pad_to_max_tokens=cfg.pad_to_max_tokens,
+ pad_to_max_seqs=cfg.pad_to_max_seqs,
+ symmetries=symmetries,
+ atoms_per_window_queries=cfg.atoms_per_window_queries,
+ min_dist=cfg.min_dist,
+ max_dist=cfg.max_dist,
+ num_bins=cfg.num_bins,
+ overfit=cfg.overfit,
+ binder_pocket_conditioned_prop=cfg.train_binder_pocket_conditioned_prop,
+ binder_pocket_cutoff=cfg.binder_pocket_cutoff,
+ binder_pocket_sampling_geometric_p=cfg.binder_pocket_sampling_geometric_p,
+ return_symmetries=cfg.return_train_symmetries,
+ compute_constraint_features=cfg.compute_constraint_features,
+ )
+ self._val_set = ValidationDataset(
+ datasets=train if cfg.overfit is not None else val,
+ seed=cfg.random_seed,
+ max_atoms=cfg.max_atoms,
+ max_tokens=cfg.max_tokens,
+ max_seqs=cfg.max_seqs,
+ pad_to_max_atoms=cfg.pad_to_max_atoms,
+ pad_to_max_tokens=cfg.pad_to_max_tokens,
+ pad_to_max_seqs=cfg.pad_to_max_seqs,
+ symmetries=symmetries,
+ atoms_per_window_queries=cfg.atoms_per_window_queries,
+ min_dist=cfg.min_dist,
+ max_dist=cfg.max_dist,
+ num_bins=cfg.num_bins,
+ overfit=cfg.overfit,
+ crop_validation=cfg.crop_validation,
+ return_symmetries=cfg.return_val_symmetries,
+ binder_pocket_conditioned_prop=cfg.val_binder_pocket_conditioned_prop,
+ binder_pocket_cutoff=cfg.binder_pocket_cutoff,
+ compute_constraint_features=cfg.compute_constraint_features,
+ )
+
+ def setup(self, stage: Optional[str] = None) -> None:
+ """Run the setup for the DataModule.
+
+ Parameters
+ ----------
+ stage : str, optional
+ The stage, one of 'fit', 'validate', 'test'.
+
+ """
+ return
+
+ def train_dataloader(self) -> DataLoader:
+ """Get the training dataloader.
+
+ Returns
+ -------
+ DataLoader
+ The training dataloader.
+
+ """
+ return DataLoader(
+ self._train_set,
+ batch_size=self.cfg.batch_size,
+ num_workers=self.cfg.num_workers,
+ pin_memory=self.cfg.pin_memory,
+ shuffle=False,
+ collate_fn=collate,
+ )
+
+ def val_dataloader(self) -> DataLoader:
+ """Get the validation dataloader.
+
+ Returns
+ -------
+ DataLoader
+ The validation dataloader.
+
+ """
+ return DataLoader(
+ self._val_set,
+ batch_size=self.cfg.val_batch_size,
+ num_workers=self.cfg.num_workers,
+ pin_memory=self.cfg.pin_memory,
+ shuffle=False,
+ collate_fn=collate,
+ )
diff --git a/forks/boltz/src/boltz/data/module/trainingv2.py b/forks/boltz/src/boltz/data/module/trainingv2.py
new file mode 100644
index 00000000..2141db17
--- /dev/null
+++ b/forks/boltz/src/boltz/data/module/trainingv2.py
@@ -0,0 +1,660 @@
+from dataclasses import dataclass
+from pathlib import Path
+from typing import Optional
+
+import numpy as np
+import pytorch_lightning as pl
+import torch
+from torch import Tensor
+from torch.utils.data import DataLoader
+
+from boltz.data.crop.cropper import Cropper
+from boltz.data.feature.featurizer import BoltzFeaturizer
+from boltz.data.feature.symmetry import get_symmetries
+from boltz.data.filter.dynamic.filter import DynamicFilter
+from boltz.data.pad import pad_to_max
+from boltz.data.sample.sampler import Sample, Sampler
+from boltz.data.tokenize.tokenizer import Tokenizer
+from boltz.data.types import MSA, Connection, Input, Manifest, Record, Structure
+
+
+@dataclass
+class DatasetConfig:
+ """Dataset configuration."""
+
+ target_dir: str
+ msa_dir: str
+ prob: float
+ sampler: Sampler
+ cropper: Cropper
+ filters: Optional[list] = None
+ split: Optional[str] = None
+ manifest_path: Optional[str] = None
+
+
+@dataclass
+class DataConfig:
+ """Data configuration."""
+
+ datasets: list[DatasetConfig]
+ filters: list[DynamicFilter]
+ featurizer: BoltzFeaturizer
+ tokenizer: Tokenizer
+ max_atoms: int
+ max_tokens: int
+ max_seqs: int
+ samples_per_epoch: int
+ batch_size: int
+ num_workers: int
+ random_seed: int
+ pin_memory: bool
+ symmetries: str
+ atoms_per_window_queries: int
+ min_dist: float
+ max_dist: float
+ num_bins: int
+ overfit: Optional[int] = None
+ pad_to_max_tokens: bool = False
+ pad_to_max_atoms: bool = False
+ pad_to_max_seqs: bool = False
+ crop_validation: bool = False
+ return_train_symmetries: bool = False
+ return_val_symmetries: bool = True
+ train_binder_pocket_conditioned_prop: float = 0.0
+ val_binder_pocket_conditioned_prop: float = 0.0
+ binder_pocket_cutoff: float = 6.0
+ binder_pocket_sampling_geometric_p: float = 0.0
+ val_batch_size: int = 1
+
+
+@dataclass
+class Dataset:
+ """Data holder."""
+
+ target_dir: Path
+ msa_dir: Path
+ manifest: Manifest
+ prob: float
+ sampler: Sampler
+ cropper: Cropper
+ tokenizer: Tokenizer
+ featurizer: BoltzFeaturizer
+
+
+def load_input(record: Record, target_dir: Path, msa_dir: Path) -> Input:
+ """Load the given input data.
+
+ Parameters
+ ----------
+ record : Record
+ The record to load.
+ target_dir : Path
+ The path to the data directory.
+ msa_dir : Path
+ The path to msa directory.
+
+ Returns
+ -------
+ Input
+ The loaded input.
+
+ """
+ # Load the structure
+ structure = np.load(target_dir / "structures" / f"{record.id}.npz")
+ structure = Structure(
+ atoms=structure["atoms"],
+ bonds=structure["bonds"],
+ residues=structure["residues"],
+ chains=structure["chains"],
+ connections=structure["connections"].astype(Connection),
+ interfaces=structure["interfaces"],
+ mask=structure["mask"],
+ )
+
+ msas = {}
+ for chain in record.chains:
+ msa_id = chain.msa_id
+ # Load the MSA for this chain, if any
+ if msa_id != -1 and msa_id != "":
+ msa = np.load(msa_dir / f"{msa_id}.npz")
+ msas[chain.chain_id] = MSA(**msa)
+
+ return Input(structure, msas)
+
+
+def collate(data: list[dict[str, Tensor]]) -> dict[str, Tensor]:
+ """Collate the data.
+
+ Parameters
+ ----------
+ data : list[dict[str, Tensor]]
+ The data to collate.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The collated data.
+
+ """
+ # Get the keys
+ keys = data[0].keys()
+
+ # Collate the data
+ collated = {}
+ for key in keys:
+ values = [d[key] for d in data]
+
+ if key not in [
+ "all_coords",
+ "all_resolved_mask",
+ "crop_to_all_atom_map",
+ "chain_symmetries",
+ "amino_acids_symmetries",
+ "ligand_symmetries",
+ ]:
+ # Check if all have the same shape
+ shape = values[0].shape
+ if not all(v.shape == shape for v in values):
+ values, _ = pad_to_max(values, 0)
+ else:
+ values = torch.stack(values, dim=0)
+
+ # Stack the values
+ collated[key] = values
+
+ return collated
+
+
+class TrainingDataset(torch.utils.data.Dataset):
+ """Base iterable dataset."""
+
+ def __init__(
+ self,
+ datasets: list[Dataset],
+ samples_per_epoch: int,
+ symmetries: dict,
+ max_atoms: int,
+ max_tokens: int,
+ max_seqs: int,
+ pad_to_max_atoms: bool = False,
+ pad_to_max_tokens: bool = False,
+ pad_to_max_seqs: bool = False,
+ atoms_per_window_queries: int = 32,
+ min_dist: float = 2.0,
+ max_dist: float = 22.0,
+ num_bins: int = 64,
+ overfit: Optional[int] = None,
+ binder_pocket_conditioned_prop: Optional[float] = 0.0,
+ binder_pocket_cutoff: Optional[float] = 6.0,
+ binder_pocket_sampling_geometric_p: Optional[float] = 0.0,
+ return_symmetries: Optional[bool] = False,
+ ) -> None:
+ """Initialize the training dataset."""
+ super().__init__()
+ self.datasets = datasets
+ self.probs = [d.prob for d in datasets]
+ self.samples_per_epoch = samples_per_epoch
+ self.symmetries = symmetries
+ self.max_tokens = max_tokens
+ self.max_seqs = max_seqs
+ self.max_atoms = max_atoms
+ self.pad_to_max_tokens = pad_to_max_tokens
+ self.pad_to_max_atoms = pad_to_max_atoms
+ self.pad_to_max_seqs = pad_to_max_seqs
+ self.atoms_per_window_queries = atoms_per_window_queries
+ self.min_dist = min_dist
+ self.max_dist = max_dist
+ self.num_bins = num_bins
+ self.binder_pocket_conditioned_prop = binder_pocket_conditioned_prop
+ self.binder_pocket_cutoff = binder_pocket_cutoff
+ self.binder_pocket_sampling_geometric_p = binder_pocket_sampling_geometric_p
+ self.return_symmetries = return_symmetries
+ self.samples = []
+ for dataset in datasets:
+ records = dataset.manifest.records
+ if overfit is not None:
+ records = records[:overfit]
+ iterator = dataset.sampler.sample(records, np.random)
+ self.samples.append(iterator)
+
+ def __getitem__(self, idx: int) -> dict[str, Tensor]:
+ """Get an item from the dataset.
+
+ Parameters
+ ----------
+ idx : int
+ The data index.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The sampled data features.
+
+ """
+ # Pick a random dataset
+ dataset_idx = np.random.choice(
+ len(self.datasets),
+ p=self.probs,
+ )
+ dataset = self.datasets[dataset_idx]
+
+ # Get a sample from the dataset
+ sample: Sample = next(self.samples[dataset_idx])
+
+ # Get the structure
+ try:
+ input_data = load_input(sample.record, dataset.target_dir, dataset.msa_dir)
+ except Exception as e:
+ print(
+ f"Failed to load input for {sample.record.id} with error {e}. Skipping."
+ )
+ return self.__getitem__(idx)
+
+ # Tokenize structure
+ try:
+ tokenized = dataset.tokenizer.tokenize(input_data)
+ except Exception as e:
+ print(f"Tokenizer failed on {sample.record.id} with error {e}. Skipping.")
+ return self.__getitem__(idx)
+
+ # Compute crop
+ try:
+ if self.max_tokens is not None:
+ tokenized = dataset.cropper.crop(
+ tokenized,
+ max_atoms=self.max_atoms,
+ max_tokens=self.max_tokens,
+ random=np.random,
+ chain_id=sample.chain_id,
+ interface_id=sample.interface_id,
+ )
+ except Exception as e:
+ print(f"Cropper failed on {sample.record.id} with error {e}. Skipping.")
+ return self.__getitem__(idx)
+
+ # Check if there are tokens
+ if len(tokenized.tokens) == 0:
+ msg = "No tokens in cropped structure."
+ raise ValueError(msg)
+
+ # Compute features
+ try:
+ features = dataset.featurizer.process(
+ tokenized,
+ training=True,
+ max_atoms=self.max_atoms if self.pad_to_max_atoms else None,
+ max_tokens=self.max_tokens if self.pad_to_max_tokens else None,
+ max_seqs=self.max_seqs,
+ pad_to_max_seqs=self.pad_to_max_seqs,
+ symmetries=self.symmetries,
+ atoms_per_window_queries=self.atoms_per_window_queries,
+ min_dist=self.min_dist,
+ max_dist=self.max_dist,
+ num_bins=self.num_bins,
+ compute_symmetries=self.return_symmetries,
+ binder_pocket_conditioned_prop=self.binder_pocket_conditioned_prop,
+ binder_pocket_cutoff=self.binder_pocket_cutoff,
+ binder_pocket_sampling_geometric_p=self.binder_pocket_sampling_geometric_p,
+ )
+ except Exception as e:
+ print(f"Featurizer failed on {sample.record.id} with error {e}. Skipping.")
+ return self.__getitem__(idx)
+
+ return features
+
+ def __len__(self) -> int:
+ """Get the length of the dataset.
+
+ Returns
+ -------
+ int
+ The length of the dataset.
+
+ """
+ return self.samples_per_epoch
+
+
+class ValidationDataset(torch.utils.data.Dataset):
+ """Base iterable dataset."""
+
+ def __init__(
+ self,
+ datasets: list[Dataset],
+ seed: int,
+ symmetries: dict,
+ max_atoms: Optional[int] = None,
+ max_tokens: Optional[int] = None,
+ max_seqs: Optional[int] = None,
+ pad_to_max_atoms: bool = False,
+ pad_to_max_tokens: bool = False,
+ pad_to_max_seqs: bool = False,
+ atoms_per_window_queries: int = 32,
+ min_dist: float = 2.0,
+ max_dist: float = 22.0,
+ num_bins: int = 64,
+ overfit: Optional[int] = None,
+ crop_validation: bool = False,
+ return_symmetries: Optional[bool] = False,
+ binder_pocket_conditioned_prop: Optional[float] = 0.0,
+ binder_pocket_cutoff: Optional[float] = 6.0,
+ ) -> None:
+ """Initialize the validation dataset."""
+ super().__init__()
+ self.datasets = datasets
+ self.max_atoms = max_atoms
+ self.max_tokens = max_tokens
+ self.max_seqs = max_seqs
+ self.seed = seed
+ self.symmetries = symmetries
+ self.random = np.random if overfit else np.random.RandomState(self.seed)
+ self.pad_to_max_tokens = pad_to_max_tokens
+ self.pad_to_max_atoms = pad_to_max_atoms
+ self.pad_to_max_seqs = pad_to_max_seqs
+ self.overfit = overfit
+ self.crop_validation = crop_validation
+ self.atoms_per_window_queries = atoms_per_window_queries
+ self.min_dist = min_dist
+ self.max_dist = max_dist
+ self.num_bins = num_bins
+ self.return_symmetries = return_symmetries
+ self.binder_pocket_conditioned_prop = binder_pocket_conditioned_prop
+ self.binder_pocket_cutoff = binder_pocket_cutoff
+
+ def __getitem__(self, idx: int) -> dict[str, Tensor]:
+ """Get an item from the dataset.
+
+ Parameters
+ ----------
+ idx : int
+ The data index.
+
+ Returns
+ -------
+ dict[str, Tensor]
+ The sampled data features.
+
+ """
+ # Pick dataset based on idx
+ for dataset in self.datasets:
+ size = len(dataset.manifest.records)
+ if self.overfit is not None:
+ size = min(size, self.overfit)
+ if idx < size:
+ break
+ idx -= size
+
+ # Get a sample from the dataset
+ record = dataset.manifest.records[idx]
+
+ # Get the structure
+ try:
+ input_data = load_input(record, dataset.target_dir, dataset.msa_dir)
+ except Exception as e:
+ print(f"Failed to load input for {record.id} with error {e}. Skipping.")
+ return self.__getitem__(0)
+
+ # Tokenize structure
+ try:
+ tokenized = dataset.tokenizer.tokenize(input_data)
+ except Exception as e:
+ print(f"Tokenizer failed on {record.id} with error {e}. Skipping.")
+ return self.__getitem__(0)
+
+ # Compute crop
+ try:
+ if self.crop_validation and (self.max_tokens is not None):
+ tokenized = dataset.cropper.crop(
+ tokenized,
+ max_tokens=self.max_tokens,
+ random=self.random,
+ max_atoms=self.max_atoms,
+ )
+ except Exception as e:
+ print(f"Cropper failed on {record.id} with error {e}. Skipping.")
+ return self.__getitem__(0)
+
+ # Check if there are tokens
+ if len(tokenized.tokens) == 0:
+ msg = "No tokens in cropped structure."
+ raise ValueError(msg)
+
+ # Compute features
+ try:
+ pad_atoms = self.crop_validation and self.pad_to_max_atoms
+ pad_tokens = self.crop_validation and self.pad_to_max_tokens
+
+ features = dataset.featurizer.process(
+ tokenized,
+ training=False,
+ max_atoms=self.max_atoms if pad_atoms else None,
+ max_tokens=self.max_tokens if pad_tokens else None,
+ max_seqs=self.max_seqs,
+ pad_to_max_seqs=self.pad_to_max_seqs,
+ symmetries=self.symmetries,
+ atoms_per_window_queries=self.atoms_per_window_queries,
+ min_dist=self.min_dist,
+ max_dist=self.max_dist,
+ num_bins=self.num_bins,
+ compute_symmetries=self.return_symmetries,
+ binder_pocket_conditioned_prop=self.binder_pocket_conditioned_prop,
+ binder_pocket_cutoff=self.binder_pocket_cutoff,
+ binder_pocket_sampling_geometric_p=1.0, # this will only sample a single pocket token
+ only_ligand_binder_pocket=True,
+ )
+ except Exception as e:
+ print(f"Featurizer failed on {record.id} with error {e}. Skipping.")
+ return self.__getitem__(0)
+
+ return features
+
+ def __len__(self) -> int:
+ """Get the length of the dataset.
+
+ Returns
+ -------
+ int
+ The length of the dataset.
+
+ """
+ if self.overfit is not None:
+ length = sum(len(d.manifest.records[: self.overfit]) for d in self.datasets)
+ else:
+ length = sum(len(d.manifest.records) for d in self.datasets)
+
+ return length
+
+
+class BoltzTrainingDataModule(pl.LightningDataModule):
+ """DataModule for boltz."""
+
+ def __init__(self, cfg: DataConfig) -> None:
+ """Initialize the DataModule.
+
+ Parameters
+ ----------
+ config : DataConfig
+ The data configuration.
+
+ """
+ super().__init__()
+ self.cfg = cfg
+
+ assert self.cfg.val_batch_size == 1, "Validation only works with batch size=1."
+
+ # Load symmetries
+ symmetries = get_symmetries(cfg.symmetries)
+
+ # Load datasets
+ train: list[Dataset] = []
+ val: list[Dataset] = []
+
+ for data_config in cfg.datasets:
+ # Set target_dir
+ target_dir = Path(data_config.target_dir)
+ msa_dir = Path(data_config.msa_dir)
+
+ # Load manifest
+ if data_config.manifest_path is not None:
+ path = Path(data_config.manifest_path)
+ else:
+ path = target_dir / "manifest.json"
+ manifest: Manifest = Manifest.load(path)
+
+ # Split records if given
+ if data_config.split is not None:
+ with Path(data_config.split).open("r") as f:
+ split = {x.lower() for x in f.read().splitlines()}
+
+ train_records = []
+ val_records = []
+ for record in manifest.records:
+ if record.id.lower() in split:
+ val_records.append(record)
+ else:
+ train_records.append(record)
+ else:
+ train_records = manifest.records
+ val_records = []
+
+ # Filter training records
+ train_records = [
+ record
+ for record in train_records
+ if all(f.filter(record) for f in cfg.filters)
+ ]
+ # Filter training records
+ if data_config.filters is not None:
+ train_records = [
+ record
+ for record in train_records
+ if all(f.filter(record) for f in data_config.filters)
+ ]
+
+ # Create train dataset
+ train_manifest = Manifest(train_records)
+ train.append(
+ Dataset(
+ target_dir,
+ msa_dir,
+ train_manifest,
+ data_config.prob,
+ data_config.sampler,
+ data_config.cropper,
+ cfg.tokenizer,
+ cfg.featurizer,
+ )
+ )
+
+ # Create validation dataset
+ if val_records:
+ val_manifest = Manifest(val_records)
+ val.append(
+ Dataset(
+ target_dir,
+ msa_dir,
+ val_manifest,
+ data_config.prob,
+ data_config.sampler,
+ data_config.cropper,
+ cfg.tokenizer,
+ cfg.featurizer,
+ )
+ )
+
+ # Print dataset sizes
+ for dataset in train:
+ dataset: Dataset
+ print(f"Training dataset size: {len(dataset.manifest.records)}")
+
+ for dataset in val:
+ dataset: Dataset
+ print(f"Validation dataset size: {len(dataset.manifest.records)}")
+
+ # Create wrapper datasets
+ self._train_set = TrainingDataset(
+ datasets=train,
+ samples_per_epoch=cfg.samples_per_epoch,
+ max_atoms=cfg.max_atoms,
+ max_tokens=cfg.max_tokens,
+ max_seqs=cfg.max_seqs,
+ pad_to_max_atoms=cfg.pad_to_max_atoms,
+ pad_to_max_tokens=cfg.pad_to_max_tokens,
+ pad_to_max_seqs=cfg.pad_to_max_seqs,
+ symmetries=symmetries,
+ atoms_per_window_queries=cfg.atoms_per_window_queries,
+ min_dist=cfg.min_dist,
+ max_dist=cfg.max_dist,
+ num_bins=cfg.num_bins,
+ overfit=cfg.overfit,
+ binder_pocket_conditioned_prop=cfg.train_binder_pocket_conditioned_prop,
+ binder_pocket_cutoff=cfg.binder_pocket_cutoff,
+ binder_pocket_sampling_geometric_p=cfg.binder_pocket_sampling_geometric_p,
+ return_symmetries=cfg.return_train_symmetries,
+ )
+ self._val_set = ValidationDataset(
+ datasets=train if cfg.overfit is not None else val,
+ seed=cfg.random_seed,
+ max_atoms=cfg.max_atoms,
+ max_tokens=cfg.max_tokens,
+ max_seqs=cfg.max_seqs,
+ pad_to_max_atoms=cfg.pad_to_max_atoms,
+ pad_to_max_tokens=cfg.pad_to_max_tokens,
+ pad_to_max_seqs=cfg.pad_to_max_seqs,
+ symmetries=symmetries,
+ atoms_per_window_queries=cfg.atoms_per_window_queries,
+ min_dist=cfg.min_dist,
+ max_dist=cfg.max_dist,
+ num_bins=cfg.num_bins,
+ overfit=cfg.overfit,
+ crop_validation=cfg.crop_validation,
+ return_symmetries=cfg.return_val_symmetries,
+ binder_pocket_conditioned_prop=cfg.val_binder_pocket_conditioned_prop,
+ binder_pocket_cutoff=cfg.binder_pocket_cutoff,
+ )
+
+ def setup(self, stage: Optional[str] = None) -> None:
+ """Run the setup for the DataModule.
+
+ Parameters
+ ----------
+ stage : str, optional
+ The stage, one of 'fit', 'validate', 'test'.
+
+ """
+ return
+
+ def train_dataloader(self) -> DataLoader:
+ """Get the training dataloader.
+
+ Returns
+ -------
+ DataLoader
+ The training dataloader.
+
+ """
+ return DataLoader(
+ self._train_set,
+ batch_size=self.cfg.batch_size,
+ num_workers=self.cfg.num_workers,
+ pin_memory=self.cfg.pin_memory,
+ shuffle=False,
+ collate_fn=collate,
+ )
+
+ def val_dataloader(self) -> DataLoader:
+ """Get the validation dataloader.
+
+ Returns
+ -------
+ DataLoader
+ The validation dataloader.
+
+ """
+ return DataLoader(
+ self._val_set,
+ batch_size=self.cfg.val_batch_size,
+ num_workers=self.cfg.num_workers,
+ pin_memory=self.cfg.pin_memory,
+ shuffle=False,
+ collate_fn=collate,
+ )
diff --git a/forks/boltz/src/boltz/data/mol.py b/forks/boltz/src/boltz/data/mol.py
new file mode 100644
index 00000000..1b98e328
--- /dev/null
+++ b/forks/boltz/src/boltz/data/mol.py
@@ -0,0 +1,900 @@
+import itertools
+import pickle
+import random
+from pathlib import Path
+
+import numpy as np
+import torch
+from rdkit.Chem import Mol
+from tqdm import tqdm
+
+from boltz.data import const
+from boltz.data.pad import pad_dim
+from boltz.model.loss.confidence import lddt_dist
+
+
+def load_molecules(moldir: str, molecules: list[str]) -> dict[str, Mol]:
+ """Load the given input data.
+
+ Parameters
+ ----------
+ moldir : str
+ The path to the molecules directory.
+ molecules : list[str]
+ The molecules to load.
+
+ Returns
+ -------
+ dict[str, Mol]
+ The loaded molecules.
+ """
+ loaded_mols = {}
+ for molecule in molecules:
+ path = Path(moldir) / f"{molecule}.pkl"
+ if not path.exists():
+ msg = f"CCD component {molecule} not found!"
+ raise ValueError(msg)
+ with path.open("rb") as f:
+ loaded_mols[molecule] = pickle.load(f) # noqa: S301
+ return loaded_mols
+
+
+def load_canonicals(moldir: str) -> dict[str, Mol]:
+ """Load the given input data.
+
+ Parameters
+ ----------
+ moldir : str
+ The molecules to load.
+
+ Returns
+ -------
+ dict[str, Mol]
+ The loaded molecules.
+
+ """
+ return load_molecules(moldir, const.canonical_tokens)
+
+
+def load_all_molecules(moldir: str) -> dict[str, Mol]:
+ """Load the given input data.
+
+ Parameters
+ ----------
+ moldir : str
+ The path to the molecules directory.
+ molecules : list[str]
+ The molecules to load.
+
+ Returns
+ -------
+ dict[str, Mol]
+ The loaded molecules.
+
+ """
+ loaded_mols = {}
+ files = list(Path(moldir).glob("*.pkl"))
+ for path in tqdm(files, total=len(files), desc="Loading molecules", leave=False):
+ mol_name = path.stem
+ with path.open("rb") as f:
+ loaded_mols[mol_name] = pickle.load(f) # noqa: S301
+ return loaded_mols
+
+
+def get_symmetries(mols: dict[str, Mol]) -> dict: # noqa: PLR0912
+ """Create a dictionary for the ligand symmetries.
+
+ Parameters
+ ----------
+ path : str
+ The path to the ligand symmetries.
+
+ Returns
+ -------
+ dict
+ The ligand symmetries.
+
+ """
+ symmetries = {}
+ for key, mol in mols.items():
+ try:
+ sym = pickle.loads(bytes.fromhex(mol.GetProp("symmetries"))) # noqa: S301
+
+ if mol.HasProp("pb_edge_index"):
+ edge_index = pickle.loads(
+ bytes.fromhex(mol.GetProp("pb_edge_index"))
+ ).astype(np.int64) # noqa: S301
+ lower_bounds = pickle.loads(
+ bytes.fromhex(mol.GetProp("pb_lower_bounds"))
+ ) # noqa: S301
+ upper_bounds = pickle.loads(
+ bytes.fromhex(mol.GetProp("pb_upper_bounds"))
+ ) # noqa: S301
+ bond_mask = pickle.loads(bytes.fromhex(mol.GetProp("pb_bond_mask"))) # noqa: S301
+ angle_mask = pickle.loads(bytes.fromhex(mol.GetProp("pb_angle_mask"))) # noqa: S301
+ else:
+ edge_index = np.empty((2, 0), dtype=np.int64)
+ lower_bounds = np.array([], dtype=np.float32)
+ upper_bounds = np.array([], dtype=np.float32)
+ bond_mask = np.array([], dtype=np.float32)
+ angle_mask = np.array([], dtype=np.float32)
+
+ if mol.HasProp("chiral_atom_index"):
+ chiral_atom_index = pickle.loads(
+ bytes.fromhex(mol.GetProp("chiral_atom_index"))
+ ).astype(np.int64)
+ chiral_check_mask = pickle.loads(
+ bytes.fromhex(mol.GetProp("chiral_check_mask"))
+ ).astype(np.int64)
+ chiral_atom_orientations = pickle.loads(
+ bytes.fromhex(mol.GetProp("chiral_atom_orientations"))
+ )
+ else:
+ chiral_atom_index = np.empty((4, 0), dtype=np.int64)
+ chiral_check_mask = np.array([], dtype=bool)
+ chiral_atom_orientations = np.array([], dtype=bool)
+
+ if mol.HasProp("stereo_bond_index"):
+ stereo_bond_index = pickle.loads(
+ bytes.fromhex(mol.GetProp("stereo_bond_index"))
+ ).astype(np.int64)
+ stereo_check_mask = pickle.loads(
+ bytes.fromhex(mol.GetProp("stereo_check_mask"))
+ ).astype(np.int64)
+ stereo_bond_orientations = pickle.loads(
+ bytes.fromhex(mol.GetProp("stereo_bond_orientations"))
+ )
+ else:
+ stereo_bond_index = np.empty((4, 0), dtype=np.int64)
+ stereo_check_mask = np.array([], dtype=bool)
+ stereo_bond_orientations = np.array([], dtype=bool)
+
+ if mol.HasProp("aromatic_5_ring_index"):
+ aromatic_5_ring_index = pickle.loads(
+ bytes.fromhex(mol.GetProp("aromatic_5_ring_index"))
+ ).astype(np.int64)
+ else:
+ aromatic_5_ring_index = np.empty((5, 0), dtype=np.int64)
+ if mol.HasProp("aromatic_6_ring_index"):
+ aromatic_6_ring_index = pickle.loads(
+ bytes.fromhex(mol.GetProp("aromatic_6_ring_index"))
+ ).astype(np.int64)
+ else:
+ aromatic_6_ring_index = np.empty((6, 0), dtype=np.int64)
+ if mol.HasProp("planar_double_bond_index"):
+ planar_double_bond_index = pickle.loads(
+ bytes.fromhex(mol.GetProp("planar_double_bond_index"))
+ ).astype(np.int64)
+ else:
+ planar_double_bond_index = np.empty((6, 0), dtype=np.int64)
+
+ atom_names = [atom.GetProp("name") for atom in mol.GetAtoms()]
+ symmetries[key] = (
+ sym,
+ atom_names,
+ edge_index,
+ lower_bounds,
+ upper_bounds,
+ bond_mask,
+ angle_mask,
+ chiral_atom_index,
+ chiral_check_mask,
+ chiral_atom_orientations,
+ stereo_bond_index,
+ stereo_check_mask,
+ stereo_bond_orientations,
+ aromatic_5_ring_index,
+ aromatic_6_ring_index,
+ planar_double_bond_index,
+ )
+ except Exception as e: # noqa: BLE001, PERF203, S110
+ pass
+
+ return symmetries
+
+
+def compute_symmetry_idx_dictionary(data):
+ # Compute the symmetry index dictionary
+ total_count = 0
+ all_coords = []
+ for i, chain in enumerate(data.chains):
+ chain.start_idx = total_count
+ for j, token in enumerate(chain.tokens):
+ token.start_idx = total_count - chain.start_idx
+ all_coords.extend(
+ [[atom.coords.x, atom.coords.y, atom.coords.z] for atom in token.atoms]
+ )
+ total_count += len(token.atoms)
+ return all_coords
+
+
+def get_current_idx_list(data):
+ idx = []
+ for chain in data.chains:
+ if chain.in_crop:
+ for token in chain.tokens:
+ if token.in_crop:
+ idx.extend(
+ [
+ chain.start_idx + token.start_idx + i
+ for i in range(len(token.atoms))
+ ]
+ )
+ return idx
+
+
+def all_different_after_swap(l):
+ final = [s[-1] for s in l]
+ return len(final) == len(set(final))
+
+
+def minimum_lddt_symmetry_coords(
+ coords: torch.Tensor,
+ feats: dict,
+ index_batch: int,
+):
+ all_coords = feats["all_coords"][index_batch].unsqueeze(0).to(coords)
+ all_resolved_mask = (
+ feats["all_resolved_mask"][index_batch].to(coords).to(torch.bool)
+ )
+ crop_to_all_atom_map = (
+ feats["crop_to_all_atom_map"][index_batch].to(coords).to(torch.long)
+ )
+ chain_symmetries = feats["chain_swaps"][index_batch]
+ amino_acids_symmetries = feats["amino_acids_symmetries"][index_batch]
+ ligand_symmetries = feats["ligand_symmetries"][index_batch]
+
+ dmat_predicted = torch.cdist(
+ coords[:, : len(crop_to_all_atom_map)], coords[:, : len(crop_to_all_atom_map)]
+ )
+
+ # Check best symmetry on chain swap
+ best_true_coords = all_coords[:, crop_to_all_atom_map].clone()
+ best_true_resolved_mask = all_resolved_mask[crop_to_all_atom_map].clone()
+ best_lddt = -1.0
+ for c in chain_symmetries:
+ true_all_coords = all_coords.clone()
+ true_all_resolved_mask = all_resolved_mask.clone()
+ for start1, end1, start2, end2, chainidx1, chainidx2 in c:
+ true_all_coords[:, start1:end1] = all_coords[:, start2:end2]
+ true_all_resolved_mask[start1:end1] = all_resolved_mask[start2:end2]
+ true_coords = true_all_coords[:, crop_to_all_atom_map]
+ true_resolved_mask = true_all_resolved_mask[crop_to_all_atom_map]
+ dmat_true = torch.cdist(true_coords, true_coords)
+ pair_mask = (
+ true_resolved_mask[:, None]
+ * true_resolved_mask[None, :]
+ * (1 - torch.eye(len(true_resolved_mask))).to(true_resolved_mask)
+ )
+
+ lddt = lddt_dist(
+ dmat_predicted, dmat_true, pair_mask, cutoff=15.0, per_atom=False
+ )[0]
+ lddt = lddt.item()
+
+ if lddt > best_lddt and torch.sum(true_resolved_mask) > 3:
+ best_lddt = lddt
+ best_true_coords = true_coords
+ best_true_resolved_mask = true_resolved_mask
+
+ # atom symmetries (nucleic acid and protein residues), resolved greedily without recomputing alignment
+ true_coords = best_true_coords.clone()
+ true_resolved_mask = best_true_resolved_mask.clone()
+ for symmetric_amino_or_lig in amino_acids_symmetries + ligand_symmetries:
+ best_lddt_improvement = 0.0
+
+ indices = set()
+ for c in symmetric_amino_or_lig:
+ for i, j in c:
+ indices.add(i)
+ indices = sorted(list(indices))
+ indices = torch.from_numpy(np.asarray(indices)).to(true_coords.device).long()
+ pred_coords_subset = coords[:, : len(crop_to_all_atom_map)][:, indices]
+ sub_dmat_pred = torch.cdist(
+ coords[:, : len(crop_to_all_atom_map)], pred_coords_subset
+ )
+
+ for c in symmetric_amino_or_lig:
+ # starting from greedy best, try to swap the atoms
+ new_true_coords = true_coords.clone()
+ new_true_resolved_mask = true_resolved_mask.clone()
+ for i, j in c:
+ new_true_coords[:, i] = true_coords[:, j]
+ new_true_resolved_mask[i] = true_resolved_mask[j]
+
+ true_coords_subset = true_coords[:, indices]
+ new_true_coords_subset = new_true_coords[:, indices]
+
+ sub_dmat_true = torch.cdist(true_coords, true_coords_subset)
+ sub_dmat_new_true = torch.cdist(new_true_coords, new_true_coords_subset)
+
+ sub_true_pair_lddt = (
+ true_resolved_mask[:, None] * true_resolved_mask[None, indices]
+ )
+ sub_true_pair_lddt[indices] = (
+ sub_true_pair_lddt[indices]
+ * (1 - torch.eye(len(indices))).to(sub_true_pair_lddt).bool()
+ )
+
+ sub_new_true_pair_lddt = (
+ new_true_resolved_mask[:, None] * new_true_resolved_mask[None, indices]
+ )
+ sub_new_true_pair_lddt[indices] = (
+ sub_new_true_pair_lddt[indices]
+ * (1 - torch.eye(len(indices))).to(sub_true_pair_lddt).bool()
+ )
+
+ lddt, total = lddt_dist(
+ sub_dmat_pred,
+ sub_dmat_true,
+ sub_true_pair_lddt,
+ cutoff=15.0,
+ per_atom=False,
+ )
+ new_lddt, new_total = lddt_dist(
+ sub_dmat_pred,
+ sub_dmat_new_true,
+ sub_new_true_pair_lddt,
+ cutoff=15.0,
+ per_atom=False,
+ )
+
+ lddt_improvement = new_lddt - lddt
+
+ if lddt_improvement > best_lddt_improvement:
+ best_true_coords = new_true_coords
+ best_true_resolved_mask = new_true_resolved_mask
+ best_lddt_improvement = lddt_improvement
+
+ # greedily update best coordinates after each amino acid
+ true_coords = best_true_coords.clone()
+ true_resolved_mask = best_true_resolved_mask.clone()
+
+ # Recomputing alignment
+ true_coords = pad_dim(true_coords, 1, coords.shape[1] - true_coords.shape[1])
+ true_resolved_mask = pad_dim(
+ true_resolved_mask,
+ 0,
+ coords.shape[1] - true_resolved_mask.shape[0],
+ )
+
+ return true_coords, true_resolved_mask.unsqueeze(0)
+
+
+def compute_single_distogram_loss(pred, target, mask):
+ # Compute the distogram loss
+ errors = -1 * torch.sum(
+ target * torch.nn.functional.log_softmax(pred, dim=-1),
+ dim=-1,
+ )
+ denom = 1e-5 + torch.sum(mask, dim=(-1, -2))
+ mean = errors * mask
+ mean = torch.sum(mean, dim=-1)
+ mean = mean / denom[..., None]
+ batch_loss = torch.sum(mean, dim=-1)
+ global_loss = torch.mean(batch_loss)
+ return global_loss
+
+
+def minimum_lddt_symmetry_dist(
+ pred_distogram: torch.Tensor,
+ feats: dict,
+ index_batch: int,
+):
+ # Note: for now only ligand symmetries are resolved
+
+ disto_target = feats["disto_target"][index_batch]
+ mask = feats["token_disto_mask"][index_batch]
+ mask = mask[None, :] * mask[:, None]
+ mask = mask * (1 - torch.eye(mask.shape[1])).to(disto_target)
+
+ coords = feats["coords"][index_batch]
+
+ ligand_symmetries = feats["ligand_symmetries"][index_batch]
+ atom_to_token_map = feats["atom_to_token"][index_batch].argmax(dim=-1)
+
+ # atom symmetries, resolved greedily without recomputing alignment
+ for symmetric_amino_or_lig in ligand_symmetries:
+ best_c, best_disto, best_loss_improvement = None, None, 0.0
+ for c in symmetric_amino_or_lig:
+ # starting from greedy best, try to swap the atoms
+ new_disto_target = disto_target.clone()
+ indices = []
+
+ # fix the distogram by replacing first the columns then the rows
+ disto_temp = new_disto_target.clone()
+ for i, j in c:
+ new_disto_target[:, atom_to_token_map[i]] = disto_temp[
+ :, atom_to_token_map[j]
+ ]
+ indices.append(atom_to_token_map[i].item())
+ disto_temp = new_disto_target.clone()
+ for i, j in c:
+ new_disto_target[atom_to_token_map[i], :] = disto_temp[
+ atom_to_token_map[j], :
+ ]
+
+ indices = (
+ torch.from_numpy(np.asarray(indices)).to(disto_target.device).long()
+ )
+
+ pred_distogram_subset = pred_distogram[:, indices]
+ disto_target_subset = disto_target[:, indices]
+ new_disto_target_subset = new_disto_target[:, indices]
+ mask_subset = mask[:, indices]
+
+ loss = compute_single_distogram_loss(
+ pred_distogram_subset, disto_target_subset, mask_subset
+ )
+ new_loss = compute_single_distogram_loss(
+ pred_distogram_subset, new_disto_target_subset, mask_subset
+ )
+ loss_improvement = (loss - new_loss) * len(indices)
+
+ if loss_improvement > best_loss_improvement:
+ best_c = c
+ best_disto = new_disto_target
+ best_loss_improvement = loss_improvement
+
+ # greedily update best coordinates after each ligand
+ if best_loss_improvement > 0:
+ disto_target = best_disto.clone()
+ old_coords = coords.clone()
+ for i, j in best_c:
+ coords[:, i] = old_coords[:, j]
+
+ # update features to be used in diffusion and in distogram loss
+ feats["disto_target"][index_batch] = disto_target
+ feats["coords"][index_batch] = coords
+ return
+
+
+def compute_all_coords_mask(structure):
+ # Compute all coords, crop mask and add start_idx to structure
+ total_count = 0
+ all_coords = []
+ all_coords_crop_mask = []
+ all_resolved_mask = []
+ for i, chain in enumerate(structure.chains):
+ chain.start_idx = total_count
+ for j, token in enumerate(chain.tokens):
+ token.start_idx = total_count - chain.start_idx
+ all_coords.extend(
+ [[atom.coords.x, atom.coords.y, atom.coords.z] for atom in token.atoms]
+ )
+ all_coords_crop_mask.extend(
+ [token.in_crop for _ in range(len(token.atoms))]
+ )
+ all_resolved_mask.extend(
+ [token.is_present for _ in range(len(token.atoms))]
+ )
+ total_count += len(token.atoms)
+ if len(all_coords_crop_mask) != len(all_resolved_mask):
+ pass
+ return all_coords, all_coords_crop_mask, all_resolved_mask
+
+
+def get_chain_symmetries(cropped, max_n_symmetries=100):
+ # get all coordinates and resolved mask
+ structure = cropped.structure
+ all_coords = []
+ all_resolved_mask = []
+ original_atom_idx = []
+ chain_atom_idx = []
+ chain_atom_num = []
+ chain_in_crop = []
+ chain_asym_id = []
+ new_atom_idx = 0
+
+ for chain in structure.chains:
+ atom_idx, atom_num = (
+ chain["atom_idx"], # Global index of first atom in the chain
+ chain["atom_num"], # Number of atoms in the chain
+ )
+
+ # compute coordinates and resolved mask
+ resolved_mask = structure.atoms["is_present"][
+ atom_idx : atom_idx + atom_num
+ ] # Whether each atom in the chain is actually resolved
+
+ # ensemble_atom_starts = [structure.ensemble[idx]["atom_coord_idx"] for idx in cropped.ensemble_ref_idxs]
+ # coords = np.array(
+ # [structure.coords[ensemble_atom_start + atom_idx: ensemble_atom_start + atom_idx + atom_num]["coords"] for
+ # ensemble_atom_start in ensemble_atom_starts])
+
+ coords = structure.atoms["coords"][atom_idx : atom_idx + atom_num]
+
+ in_crop = False
+ for token in cropped.tokens:
+ if token["asym_id"] == chain["asym_id"]:
+ in_crop = True
+ break
+
+ all_coords.append(coords)
+ all_resolved_mask.append(resolved_mask)
+ original_atom_idx.append(atom_idx)
+ chain_atom_idx.append(new_atom_idx)
+ chain_atom_num.append(atom_num)
+ chain_in_crop.append(in_crop)
+ chain_asym_id.append(chain["asym_id"])
+
+ new_atom_idx += atom_num
+
+ all_coords = np.concatenate(all_coords, axis=0)
+ # Compute backmapping from token to all coords
+ crop_to_all_atom_map = []
+ for token in cropped.tokens:
+ chain_idx = chain_asym_id.index(token["asym_id"])
+ start = (
+ chain_atom_idx[chain_idx] - original_atom_idx[chain_idx] + token["atom_idx"]
+ )
+ crop_to_all_atom_map.append(np.arange(start, start + token["atom_num"]))
+ crop_to_all_atom_map = np.concatenate(crop_to_all_atom_map, axis=0)
+
+ # Compute the connections edge index for covalent bonds
+ all_atom_to_crop_map = np.zeros(all_coords.shape[0], dtype=np.int64)
+ all_atom_to_crop_map[crop_to_all_atom_map.astype(np.int64)] = np.arange(
+ crop_to_all_atom_map.shape[0]
+ )
+ connections_edge_index = []
+ for connection in structure.bonds:
+ if (connection["chain_1"] == connection["chain_2"]) and (
+ connection["res_1"] == connection["res_2"]
+ ):
+ continue
+ connections_edge_index.append([connection["atom_1"], connection["atom_2"]])
+ if len(connections_edge_index) > 0:
+ connections_edge_index = np.array(connections_edge_index, dtype=np.int64).T
+ connections_edge_index = all_atom_to_crop_map[connections_edge_index]
+ else:
+ connections_edge_index = np.empty((2, 0))
+
+ # Compute the symmetries between chains
+ symmetries = []
+ swaps = []
+ for i, chain in enumerate(structure.chains):
+ start = chain_atom_idx[i]
+ end = start + chain_atom_num[i]
+
+ if chain_in_crop[i]:
+ possible_swaps = []
+ for j, chain2 in enumerate(structure.chains):
+ start2 = chain_atom_idx[j]
+ end2 = start2 + chain_atom_num[j]
+ if (
+ chain["entity_id"] == chain2["entity_id"]
+ and end - start == end2 - start2
+ ):
+ possible_swaps.append((start, end, start2, end2, i, j))
+ swaps.append(possible_swaps)
+
+ found = False
+ for symmetry_idx, symmetry in enumerate(symmetries):
+ j = symmetry[0][0]
+ chain2 = structure.chains[j]
+ start2 = chain_atom_idx[j]
+ end2 = start2 + chain_atom_num[j]
+ if (
+ chain["entity_id"] == chain2["entity_id"]
+ and end - start == end2 - start2
+ ):
+ symmetries[symmetry_idx].append(
+ (i, start, end, chain_in_crop[i], chain["mol_type"])
+ )
+ found = True
+ if not found:
+ symmetries.append([(i, start, end, chain_in_crop[i], chain["mol_type"])])
+
+ combinations = itertools.product(*swaps)
+ # to avoid combinatorial explosion, bound the number of combinations even considered
+ combinations = list(itertools.islice(combinations, max_n_symmetries * 10))
+ # filter for all chains getting a different assignment
+ combinations = [c for c in combinations if all_different_after_swap(c)]
+
+ if len(combinations) > max_n_symmetries:
+ combinations = random.sample(combinations, max_n_symmetries)
+
+ if len(combinations) == 0:
+ combinations.append([])
+
+ for i in range(len(symmetries) - 1, -1, -1):
+ if not any(chain[3] for chain in symmetries[i]):
+ symmetries.pop(i)
+
+ features = {}
+ features["all_coords"] = torch.Tensor(all_coords) # axis=1 with ensemble
+
+ features["all_resolved_mask"] = torch.Tensor(
+ np.concatenate(all_resolved_mask, axis=0)
+ )
+ features["crop_to_all_atom_map"] = torch.Tensor(crop_to_all_atom_map)
+ features["chain_symmetries"] = symmetries
+ features["connections_edge_index"] = torch.tensor(connections_edge_index)
+ features["chain_swaps"] = combinations
+
+ return features
+
+
+def get_amino_acids_symmetries(cropped):
+ # Compute standard amino-acids symmetries
+ swaps = []
+ start_index_crop = 0
+ for token in cropped.tokens:
+ symmetries = const.ref_symmetries.get(const.tokens[token["res_type"]], [])
+ if len(symmetries) > 0:
+ residue_swaps = []
+ for sym in symmetries:
+ sym_new_idx = [
+ (i + start_index_crop, j + start_index_crop) for i, j in sym
+ ]
+ residue_swaps.append(sym_new_idx)
+ swaps.append(residue_swaps)
+ start_index_crop += token["atom_num"]
+
+ features = {"amino_acids_symmetries": swaps}
+ return features
+
+
+def slice_valid_index(index, ccd_to_valid_id_array, args=None):
+ index = ccd_to_valid_id_array[index]
+ valid_index_mask = (~np.isnan(index)).all(axis=0)
+ index = index[:, valid_index_mask]
+ if args is None:
+ return index
+ args = (arg[valid_index_mask] for arg in args)
+ return index, args
+
+
+def get_ligand_symmetries(cropped, symmetries, return_physical_metrics=False):
+ # Compute ligand and non-standard amino-acids symmetries
+ structure = cropped.structure
+
+ added_molecules = {}
+ index_mols = []
+ atom_count = 0
+
+ for token in cropped.tokens:
+ # check if molecule is already added by identifying it through asym_id and res_idx
+ atom_count += token["atom_num"]
+ mol_id = (token["asym_id"], token["res_idx"])
+ if mol_id in added_molecules:
+ added_molecules[mol_id] += token["atom_num"]
+ continue
+ added_molecules[mol_id] = token["atom_num"]
+
+ # get the molecule type and indices
+ residue_idx = token["res_idx"] + structure.chains[token["asym_id"]]["res_idx"]
+ mol_name = structure.residues[residue_idx]["name"]
+ atom_idx = structure.residues[residue_idx]["atom_idx"]
+ mol_atom_names = structure.atoms[
+ atom_idx : atom_idx + structure.residues[residue_idx]["atom_num"]
+ ]["name"]
+ if mol_name not in const.ref_symmetries:
+ index_mols.append(
+ (mol_name, atom_count - token["atom_num"], mol_id, mol_atom_names)
+ )
+
+ # for each molecule, get the symmetries
+ molecule_symmetries = []
+ all_edge_index = []
+ all_lower_bounds, all_upper_bounds = [], []
+ all_bond_mask, all_angle_mask = [], []
+ all_chiral_atom_index, all_chiral_check_mask, all_chiral_atom_orientations = (
+ [],
+ [],
+ [],
+ )
+ all_stereo_bond_index, all_stereo_check_mask, all_stereo_bond_orientations = (
+ [],
+ [],
+ [],
+ )
+ (
+ all_aromatic_5_ring_index,
+ all_aromatic_6_ring_index,
+ all_planar_double_bond_index,
+ ) = (
+ [],
+ [],
+ [],
+ )
+ for mol_name, start_mol, mol_id, mol_atom_names in index_mols:
+ if not mol_name in symmetries:
+ continue
+ else:
+ swaps = []
+ (
+ syms_ccd,
+ mol_atom_names_ccd,
+ edge_index,
+ lower_bounds,
+ upper_bounds,
+ bond_mask,
+ angle_mask,
+ chiral_atom_index,
+ chiral_check_mask,
+ chiral_atom_orientations,
+ stereo_bond_index,
+ stereo_check_mask,
+ stereo_bond_orientations,
+ aromatic_5_ring_index,
+ aromatic_6_ring_index,
+ planar_double_bond_index,
+ ) = symmetries[mol_name]
+ # Get indices of mol_atom_names_ccd that are in mol_atom_names
+ ccd_to_valid_ids = {
+ mol_atom_names_ccd.index(name): i
+ for i, name in enumerate(mol_atom_names)
+ }
+ ccd_to_valid_id_array = np.array(
+ [
+ float("nan") if i not in ccd_to_valid_ids else ccd_to_valid_ids[i]
+ for i in range(len(mol_atom_names_ccd))
+ ]
+ )
+ ccd_valid_ids = set(ccd_to_valid_ids.keys())
+ syms = []
+ # Get syms
+ for sym_ccd in syms_ccd:
+ sym_dict = {}
+ bool_add = True
+ for i, j in enumerate(sym_ccd):
+ if i in ccd_valid_ids:
+ if j in ccd_valid_ids:
+ i_true = ccd_to_valid_ids[i]
+ j_true = ccd_to_valid_ids[j]
+ sym_dict[i_true] = j_true
+ else:
+ bool_add = False
+ break
+ if bool_add:
+ syms.append([sym_dict[i] for i in range(len(ccd_valid_ids))])
+ for sym in syms:
+ if len(sym) != added_molecules[mol_id]:
+ raise Exception(
+ f"Symmetry length mismatch {len(sym)} {added_molecules[mol_id]}"
+ )
+ # assert (
+ # len(sym) == added_molecules[mol_id]
+ # ), f"Symmetry length mismatch {len(sym)} {added_molecules[mol_id]}"
+ sym_new_idx = []
+ for i, j in enumerate(sym):
+ if i != int(j):
+ sym_new_idx.append((i + start_mol, int(j) + start_mol))
+ if len(sym_new_idx) > 0:
+ swaps.append(sym_new_idx)
+
+ if len(swaps) > 0:
+ molecule_symmetries.append(swaps)
+
+ if return_physical_metrics:
+ edge_index, (lower_bounds, upper_bounds, bond_mask, angle_mask) = (
+ slice_valid_index(
+ edge_index,
+ ccd_to_valid_id_array,
+ (lower_bounds, upper_bounds, bond_mask, angle_mask),
+ )
+ )
+ all_edge_index.append(edge_index + start_mol)
+ all_lower_bounds.append(lower_bounds)
+ all_upper_bounds.append(upper_bounds)
+ all_bond_mask.append(bond_mask)
+ all_angle_mask.append(angle_mask)
+
+ chiral_atom_index, (chiral_check_mask, chiral_atom_orientations) = (
+ slice_valid_index(
+ chiral_atom_index,
+ ccd_to_valid_id_array,
+ (chiral_check_mask, chiral_atom_orientations),
+ )
+ )
+ all_chiral_atom_index.append(chiral_atom_index + start_mol)
+ all_chiral_check_mask.append(chiral_check_mask)
+ all_chiral_atom_orientations.append(chiral_atom_orientations)
+
+ stereo_bond_index, (stereo_check_mask, stereo_bond_orientations) = (
+ slice_valid_index(
+ stereo_bond_index,
+ ccd_to_valid_id_array,
+ (stereo_check_mask, stereo_bond_orientations),
+ )
+ )
+ all_stereo_bond_index.append(stereo_bond_index + start_mol)
+ all_stereo_check_mask.append(stereo_check_mask)
+ all_stereo_bond_orientations.append(stereo_bond_orientations)
+
+ aromatic_5_ring_index = slice_valid_index(
+ aromatic_5_ring_index, ccd_to_valid_id_array
+ )
+ aromatic_6_ring_index = slice_valid_index(
+ aromatic_6_ring_index, ccd_to_valid_id_array
+ )
+ planar_double_bond_index = slice_valid_index(
+ planar_double_bond_index, ccd_to_valid_id_array
+ )
+ all_aromatic_5_ring_index.append(aromatic_5_ring_index + start_mol)
+ all_aromatic_6_ring_index.append(aromatic_6_ring_index + start_mol)
+ all_planar_double_bond_index.append(
+ planar_double_bond_index + start_mol
+ )
+
+ if return_physical_metrics:
+ if len(all_edge_index) > 0:
+ all_edge_index = np.concatenate(all_edge_index, axis=1)
+ all_lower_bounds = np.concatenate(all_lower_bounds, axis=0)
+ all_upper_bounds = np.concatenate(all_upper_bounds, axis=0)
+ all_bond_mask = np.concatenate(all_bond_mask, axis=0)
+ all_angle_mask = np.concatenate(all_angle_mask, axis=0)
+
+ all_chiral_atom_index = np.concatenate(all_chiral_atom_index, axis=1)
+ all_chiral_check_mask = np.concatenate(all_chiral_check_mask, axis=0)
+ all_chiral_atom_orientations = np.concatenate(
+ all_chiral_atom_orientations, axis=0
+ )
+
+ all_stereo_bond_index = np.concatenate(all_stereo_bond_index, axis=1)
+ all_stereo_check_mask = np.concatenate(all_stereo_check_mask, axis=0)
+ all_stereo_bond_orientations = np.concatenate(
+ all_stereo_bond_orientations, axis=0
+ )
+
+ all_aromatic_5_ring_index = np.concatenate(
+ all_aromatic_5_ring_index, axis=1
+ )
+ all_aromatic_6_ring_index = np.concatenate(
+ all_aromatic_6_ring_index, axis=1
+ )
+ all_planar_double_bond_index = np.empty(
+ (6, 0), dtype=np.int64
+ ) # TODO remove np.concatenate(all_planar_double_bond_index, axis=1)
+ else:
+ all_edge_index = np.empty((2, 0), dtype=np.int64)
+ all_lower_bounds = np.array([], dtype=np.float32)
+ all_upper_bounds = np.array([], dtype=np.float32)
+ all_bond_mask = np.array([], dtype=bool)
+ all_angle_mask = np.array([], dtype=bool)
+
+ all_chiral_atom_index = np.empty((4, 0), dtype=np.int64)
+ all_chiral_check_mask = np.array([], dtype=bool)
+ all_chiral_atom_orientations = np.array([], dtype=bool)
+
+ all_stereo_bond_index = np.empty((4, 0), dtype=np.int64)
+ all_stereo_check_mask = np.array([], dtype=bool)
+ all_stereo_bond_orientations = np.array([], dtype=bool)
+
+ all_aromatic_5_ring_index = np.empty((5, 0), dtype=np.int64)
+ all_aromatic_6_ring_index = np.empty((6, 0), dtype=np.int64)
+ all_planar_double_bond_index = np.empty((6, 0), dtype=np.int64)
+
+ features = {
+ "ligand_symmetries": molecule_symmetries,
+ "ligand_edge_index": torch.tensor(all_edge_index).long(),
+ "ligand_edge_lower_bounds": torch.tensor(all_lower_bounds),
+ "ligand_edge_upper_bounds": torch.tensor(all_upper_bounds),
+ "ligand_edge_bond_mask": torch.tensor(all_bond_mask),
+ "ligand_edge_angle_mask": torch.tensor(all_angle_mask),
+ "ligand_chiral_atom_index": torch.tensor(all_chiral_atom_index).long(),
+ "ligand_chiral_check_mask": torch.tensor(all_chiral_check_mask),
+ "ligand_chiral_atom_orientations": torch.tensor(
+ all_chiral_atom_orientations
+ ),
+ "ligand_stereo_bond_index": torch.tensor(all_stereo_bond_index).long(),
+ "ligand_stereo_check_mask": torch.tensor(all_stereo_check_mask),
+ "ligand_stereo_bond_orientations": torch.tensor(
+ all_stereo_bond_orientations
+ ),
+ "ligand_aromatic_5_ring_index": torch.tensor(
+ all_aromatic_5_ring_index
+ ).long(),
+ "ligand_aromatic_6_ring_index": torch.tensor(
+ all_aromatic_6_ring_index
+ ).long(),
+ "ligand_planar_double_bond_index": torch.tensor(
+ all_planar_double_bond_index
+ ).long(),
+ }
+ else:
+ features = {
+ "ligand_symmetries": molecule_symmetries,
+ }
+ return features
diff --git a/forks/boltz/src/boltz/data/msa/__init__.py b/forks/boltz/src/boltz/data/msa/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/data/msa/mmseqs2.py b/forks/boltz/src/boltz/data/msa/mmseqs2.py
new file mode 100644
index 00000000..f2aab6e8
--- /dev/null
+++ b/forks/boltz/src/boltz/data/msa/mmseqs2.py
@@ -0,0 +1,286 @@
+# From https://github.com/sokrypton/ColabFold/blob/main/colabfold/colabfold.py
+
+import logging
+import os
+import random
+import tarfile
+import time
+from typing import Optional, Union, Dict
+
+import requests
+from requests.auth import HTTPBasicAuth
+from tqdm import tqdm
+
+logger = logging.getLogger(__name__)
+
+TQDM_BAR_FORMAT = (
+ "{l_bar}{bar}| {n_fmt}/{total_fmt} [elapsed: {elapsed} remaining: {remaining}]"
+)
+
+
+def run_mmseqs2( # noqa: PLR0912, D103, C901, PLR0915
+ x: Union[str, list[str]],
+ prefix: str = "tmp",
+ use_env: bool = True,
+ use_filter: bool = True,
+ use_pairing: bool = False,
+ pairing_strategy: str = "greedy",
+ host_url: str = "https://api.colabfold.com",
+ msa_server_username: Optional[str] = None,
+ msa_server_password: Optional[str] = None,
+ auth_headers: Optional[Dict[str, str]] = None,
+) -> tuple[list[str], list[str]]:
+ submission_endpoint = "ticket/pair" if use_pairing else "ticket/msa"
+
+ # Validate mutually exclusive authentication methods
+ has_basic_auth = msa_server_username and msa_server_password
+ has_header_auth = auth_headers is not None
+ if has_basic_auth and (has_header_auth or auth_headers):
+ raise ValueError(
+ "Cannot use both basic authentication (username/password) and header/API key authentication. "
+ "Please use only one authentication method."
+ )
+
+ # Set header agent as boltz
+ headers = {}
+ headers["User-Agent"] = "boltz"
+
+ # Set up authentication
+ auth = None
+ if has_basic_auth:
+ auth = HTTPBasicAuth(msa_server_username, msa_server_password)
+ logger.debug(f"MMSeqs2 server authentication: using basic auth for user '{msa_server_username}'")
+ elif has_header_auth:
+ headers.update(auth_headers)
+ logger.debug("MMSeqs2 server authentication: using header-based authentication")
+ else:
+ logger.debug("MMSeqs2 server authentication: no credentials provided")
+
+ logger.debug(f"Connecting to MMSeqs2 server at: {host_url}")
+ logger.debug(f"Using endpoint: {submission_endpoint}")
+ logger.debug(f"Pairing strategy: {pairing_strategy}")
+ logger.debug(f"Use environment databases: {use_env}")
+ logger.debug(f"Use filtering: {use_filter}")
+
+ def submit(seqs, mode, N=101):
+ n, query = N, ""
+ for seq in seqs:
+ query += f">{n}\n{seq}\n"
+ n += 1
+
+ error_count = 0
+ while True:
+ try:
+ # https://requests.readthedocs.io/en/latest/user/advanced/#advanced
+ # "good practice to set connect timeouts to slightly larger than a multiple of 3"
+ logger.debug(f"Submitting MSA request to {host_url}/{submission_endpoint}")
+ res = requests.post(
+ f"{host_url}/{submission_endpoint}",
+ data={"q": query, "mode": mode},
+ timeout=6.02,
+ headers=headers,
+ auth=auth,
+ )
+ logger.debug(f"MSA submission response status: {res.status_code}")
+ except Exception as e:
+ error_count += 1
+ logger.warning(
+ f"Error while fetching result from MSA server. Retrying... ({error_count}/5)"
+ )
+ logger.warning(f"Error: {e}")
+ if error_count > 5:
+ raise Exception(
+ "Too many failed attempts for the MSA generation request."
+ )
+ time.sleep(5)
+ else:
+ break
+
+ try:
+ out = res.json()
+ except ValueError:
+ logger.error(f"Server didn't reply with json: {res.text}")
+ out = {"status": "ERROR"}
+ return out
+
+ def status(ID):
+ error_count = 0
+ while True:
+ try:
+ logger.debug(f"Checking MSA job status for ID: {ID}")
+ res = requests.get(
+ f"{host_url}/ticket/{ID}", timeout=6.02, headers=headers, auth=auth
+ )
+ logger.debug(f"MSA status check response status: {res.status_code}")
+ except Exception as e:
+ error_count += 1
+ logger.warning(
+ f"Error while fetching result from MSA server. Retrying... ({error_count}/5)"
+ )
+ logger.warning(f"Error: {e}")
+ if error_count > 5:
+ raise Exception(
+ "Too many failed attempts for the MSA generation request."
+ )
+ time.sleep(5)
+ else:
+ break
+ try:
+ out = res.json()
+ except ValueError:
+ logger.error(f"Server didn't reply with json: {res.text}")
+ out = {"status": "ERROR"}
+ return out
+
+ def download(ID, path):
+ error_count = 0
+ while True:
+ try:
+ logger.debug(f"Downloading MSA results for ID: {ID}")
+ res = requests.get(
+ f"{host_url}/result/download/{ID}", timeout=6.02, headers=headers, auth=auth
+ )
+ logger.debug(f"MSA download response status: {res.status_code}")
+ except Exception as e:
+ error_count += 1
+ logger.warning(
+ f"Error while fetching result from MSA server. Retrying... ({error_count}/5)"
+ )
+ logger.warning(f"Error: {e}")
+ if error_count > 5:
+ raise Exception(
+ "Too many failed attempts for the MSA generation request."
+ )
+ time.sleep(5)
+ else:
+ break
+ with open(path, "wb") as out:
+ out.write(res.content)
+
+ # process input x
+ seqs = [x] if isinstance(x, str) else x
+
+ # setup mode
+ if use_filter:
+ mode = "env" if use_env else "all"
+ else:
+ mode = "env-nofilter" if use_env else "nofilter"
+
+ if use_pairing:
+ mode = ""
+ # greedy is default, complete was the previous behavior
+ if pairing_strategy == "greedy":
+ mode = "pairgreedy"
+ elif pairing_strategy == "complete":
+ mode = "paircomplete"
+ if use_env:
+ mode = mode + "-env"
+
+ # define path
+ path = f"{prefix}_{mode}"
+ if not os.path.isdir(path):
+ os.mkdir(path)
+
+ # call mmseqs2 api
+ tar_gz_file = f"{path}/out.tar.gz"
+ N, REDO = 101, True
+
+ # deduplicate and keep track of order
+ seqs_unique = []
+ # TODO this might be slow for large sets
+ [seqs_unique.append(x) for x in seqs if x not in seqs_unique]
+ Ms = [N + seqs_unique.index(seq) for seq in seqs]
+ # lets do it!
+ if not os.path.isfile(tar_gz_file):
+ TIME_ESTIMATE = 150 * len(seqs_unique)
+ with tqdm(total=TIME_ESTIMATE, bar_format=TQDM_BAR_FORMAT) as pbar:
+ while REDO:
+ pbar.set_description("SUBMIT")
+
+ # Resubmit job until it goes through
+ out = submit(seqs_unique, mode, N)
+ while out["status"] in ["UNKNOWN", "RATELIMIT"]:
+ sleep_time = 5 + random.randint(0, 5)
+ logger.error(f"Sleeping for {sleep_time}s. Reason: {out['status']}")
+ # resubmit
+ time.sleep(sleep_time)
+ out = submit(seqs_unique, mode, N)
+
+ if out["status"] == "ERROR":
+ msg = (
+ "MMseqs2 API is giving errors. Please confirm your "
+ " input is a valid protein sequence. If error persists, "
+ "please try again an hour later."
+ )
+ raise Exception(msg)
+
+ if out["status"] == "MAINTENANCE":
+ msg = (
+ "MMseqs2 API is undergoing maintenance. "
+ "Please try again in a few minutes."
+ )
+ raise Exception(msg)
+
+ # wait for job to finish
+ ID, TIME = out["id"], 0
+ logger.debug(f"MSA job submitted successfully with ID: {ID}")
+ pbar.set_description(out["status"])
+ while out["status"] in ["UNKNOWN", "RUNNING", "PENDING"]:
+ t = 5 + random.randint(0, 5)
+ logger.error(f"Sleeping for {t}s. Reason: {out['status']}")
+ time.sleep(t)
+ out = status(ID)
+ pbar.set_description(out["status"])
+ if out["status"] == "RUNNING":
+ TIME += t
+ pbar.update(n=t)
+
+ if out["status"] == "COMPLETE":
+ logger.debug(f"MSA job completed successfully for ID: {ID}")
+ if TIME < TIME_ESTIMATE:
+ pbar.update(n=(TIME_ESTIMATE - TIME))
+ REDO = False
+
+ if out["status"] == "ERROR":
+ REDO = False
+ msg = (
+ "MMseqs2 API is giving errors. Please confirm your "
+ " input is a valid protein sequence. If error persists, "
+ "please try again an hour later."
+ )
+ raise Exception(msg)
+
+ # Download results
+ download(ID, tar_gz_file)
+
+ # prep list of a3m files
+ if use_pairing:
+ a3m_files = [f"{path}/pair.a3m"]
+ else:
+ a3m_files = [f"{path}/uniref.a3m"]
+ if use_env:
+ a3m_files.append(f"{path}/bfd.mgnify30.metaeuk30.smag30.a3m")
+
+ # extract a3m files
+ if any(not os.path.isfile(a3m_file) for a3m_file in a3m_files):
+ with tarfile.open(tar_gz_file) as tar_gz:
+ tar_gz.extractall(path)
+
+ # gather a3m lines
+ a3m_lines = {}
+ for a3m_file in a3m_files:
+ update_M, M = True, None
+ for line in open(a3m_file, "r"):
+ if len(line) > 0:
+ if "\x00" in line:
+ line = line.replace("\x00", "")
+ update_M = True
+ if line.startswith(">") and update_M:
+ M = int(line[1:].rstrip())
+ update_M = False
+ if M not in a3m_lines:
+ a3m_lines[M] = []
+ a3m_lines[M].append(line)
+
+ a3m_lines = ["".join(a3m_lines[n]) for n in Ms]
+ return a3m_lines
diff --git a/forks/boltz/src/boltz/data/pad.py b/forks/boltz/src/boltz/data/pad.py
new file mode 100644
index 00000000..fe655e6a
--- /dev/null
+++ b/forks/boltz/src/boltz/data/pad.py
@@ -0,0 +1,84 @@
+import torch
+from torch import Tensor
+from torch.nn.functional import pad
+
+
+def pad_dim(data: Tensor, dim: int, pad_len: float, value: float = 0) -> Tensor:
+ """Pad a tensor along a given dimension.
+
+ Parameters
+ ----------
+ data : Tensor
+ The input tensor.
+ dim : int
+ The dimension to pad.
+ pad_len : float
+ The padding length.
+ value : int, optional
+ The value to pad with.
+
+ Returns
+ -------
+ Tensor
+ The padded tensor.
+
+ """
+ if pad_len == 0:
+ return data
+
+ total_dims = len(data.shape)
+ padding = [0] * (2 * (total_dims - dim))
+ padding[2 * (total_dims - 1 - dim) + 1] = pad_len
+ return pad(data, tuple(padding), value=value)
+
+
+def pad_to_max(data: list[Tensor], value: float = 0) -> tuple[Tensor, Tensor]:
+ """Pad the data in all dimensions to the maximum found.
+
+ Parameters
+ ----------
+ data : list[Tensor]
+ list of tensors to pad.
+ value : float
+ The value to use for padding.
+
+ Returns
+ -------
+ Tensor
+ The padded tensor.
+ Tensor
+ The padding mask.
+
+ """
+ if isinstance(data[0], str):
+ return data, 0
+
+ # Check if all have the same shape
+ if all(d.shape == data[0].shape for d in data):
+ return torch.stack(data, dim=0), 0
+
+ # Get the maximum in each dimension
+ num_dims = len(data[0].shape)
+ max_dims = [max(d.shape[i] for d in data) for i in range(num_dims)]
+
+ # Get the padding lengths
+ pad_lengths = []
+ for d in data:
+ dims = []
+ for i in range(num_dims):
+ dims.append(0)
+ dims.append(max_dims[num_dims - i - 1] - d.shape[num_dims - i - 1])
+ pad_lengths.append(dims)
+
+ # Pad the data
+ padding = [
+ pad(torch.ones_like(d), pad_len, value=0)
+ for d, pad_len in zip(data, pad_lengths)
+ ]
+ data = [pad(d, pad_len, value=value) for d, pad_len in zip(data, pad_lengths)]
+
+ # Stack the data
+ padding = torch.stack(padding, dim=0)
+ data = torch.stack(data, dim=0)
+
+ return data, padding
diff --git a/forks/boltz/src/boltz/data/parse/__init__.py b/forks/boltz/src/boltz/data/parse/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/data/parse/a3m.py b/forks/boltz/src/boltz/data/parse/a3m.py
new file mode 100644
index 00000000..9df97140
--- /dev/null
+++ b/forks/boltz/src/boltz/data/parse/a3m.py
@@ -0,0 +1,134 @@
+import gzip
+from pathlib import Path
+from typing import Optional, TextIO
+
+import numpy as np
+
+from boltz.data import const
+from boltz.data.types import MSA, MSADeletion, MSAResidue, MSASequence
+
+
+def _parse_a3m( # noqa: C901
+ lines: TextIO,
+ taxonomy: Optional[dict[str, str]],
+ max_seqs: Optional[int] = None,
+) -> MSA:
+ """Process an MSA file.
+
+ Parameters
+ ----------
+ lines : TextIO
+ The lines of the MSA file.
+ taxonomy : dict[str, str]
+ The taxonomy database, if available.
+ max_seqs : int, optional
+ The maximum number of sequences.
+
+ Returns
+ -------
+ MSA
+ The MSA object.
+
+ """
+ visited = set()
+ sequences = []
+ deletions = []
+ residues = []
+
+ seq_idx = 0
+ for line in lines:
+ line: str
+ line = line.strip() # noqa: PLW2901
+ if not line or line.startswith("#"):
+ continue
+
+ # Get taxonomy, if annotated
+ if line.startswith(">"):
+ header = line.split()[0]
+ if taxonomy and header.startswith(">UniRef100"):
+ uniref_id = header.split("_")[1]
+ taxonomy_id = taxonomy.get(uniref_id)
+ if taxonomy_id is None:
+ taxonomy_id = -1
+ else:
+ taxonomy_id = -1
+ continue
+
+ # Skip if duplicate sequence
+ str_seq = line.replace("-", "").upper()
+ if str_seq not in visited:
+ visited.add(str_seq)
+ else:
+ continue
+
+ # Process sequence
+ residue = []
+ deletion = []
+ count = 0
+ res_idx = 0
+ for c in line:
+ if c != "-" and c.islower():
+ count += 1
+ continue
+ token = const.prot_letter_to_token[c]
+ token = const.token_ids[token]
+ residue.append(token)
+ if count > 0:
+ deletion.append((res_idx, count))
+ count = 0
+ res_idx += 1
+
+ res_start = len(residues)
+ res_end = res_start + len(residue)
+
+ del_start = len(deletions)
+ del_end = del_start + len(deletion)
+
+ sequences.append((seq_idx, taxonomy_id, res_start, res_end, del_start, del_end))
+ residues.extend(residue)
+ deletions.extend(deletion)
+
+ seq_idx += 1
+ if (max_seqs is not None) and (seq_idx >= max_seqs):
+ break
+
+ # Create MSA object
+ msa = MSA(
+ residues=np.array(residues, dtype=MSAResidue),
+ deletions=np.array(deletions, dtype=MSADeletion),
+ sequences=np.array(sequences, dtype=MSASequence),
+ )
+ return msa
+
+
+def parse_a3m(
+ path: Path,
+ taxonomy: Optional[dict[str, str]],
+ max_seqs: Optional[int] = None,
+) -> MSA:
+ """Process an A3M file.
+
+ Parameters
+ ----------
+ path : Path
+ The path to the a3m(.gz) file.
+ taxonomy : Redis
+ The taxonomy database.
+ max_seqs : int, optional
+ The maximum number of sequences.
+
+ Returns
+ -------
+ MSA
+ The MSA object.
+
+ """
+ # Read the file
+ if path.suffix == ".gz":
+ with gzip.open(str(path), "rt") as f:
+ msa = _parse_a3m(f, taxonomy, max_seqs)
+ else:
+ with path.open("r") as f:
+ msa = _parse_a3m(f, taxonomy, max_seqs)
+
+ return msa
diff --git a/forks/boltz/src/boltz/data/parse/csv.py b/forks/boltz/src/boltz/data/parse/csv.py
new file mode 100644
index 00000000..cf26866a
--- /dev/null
+++ b/forks/boltz/src/boltz/data/parse/csv.py
@@ -0,0 +1,100 @@
+from pathlib import Path
+from typing import Optional
+
+import numpy as np
+import pandas as pd
+
+from boltz.data import const
+from boltz.data.types import MSA, MSADeletion, MSAResidue, MSASequence
+
+
+def parse_csv(
+ path: Path,
+ max_seqs: Optional[int] = None,
+) -> MSA:
+ """Process an A3M file.
+
+ Parameters
+ ----------
+ path : Path
+ The path to the a3m(.gz) file.
+ max_seqs : int, optional
+ The maximum number of sequences.
+
+ Returns
+ -------
+ MSA
+ The MSA object.
+
+ """
+ # Read file
+ data = pd.read_csv(path)
+
+ # Check columns
+ if tuple(sorted(data.columns)) != ("key", "sequence"):
+ msg = "Invalid CSV format, expected columns: ['sequence', 'key']"
+ raise ValueError(msg)
+
+ # Create taxonomy mapping
+ visited = set()
+ sequences = []
+ deletions = []
+ residues = []
+
+ seq_idx = 0
+ for line, key in zip(data["sequence"], data["key"]):
+ line: str
+ line = line.strip() # noqa: PLW2901
+ if not line:
+ continue
+
+ # Get taxonomy, if annotated
+ taxonomy_id = -1
+ if (str(key) != "nan") and (key is not None) and (key != ""):
+ taxonomy_id = key
+
+ # Skip if duplicate sequence
+ str_seq = line.replace("-", "").upper()
+ if str_seq not in visited:
+ visited.add(str_seq)
+ else:
+ continue
+
+ # Process sequence
+ residue = []
+ deletion = []
+ count = 0
+ res_idx = 0
+ for c in line:
+ if c != "-" and c.islower():
+ count += 1
+ continue
+ token = const.prot_letter_to_token[c]
+ token = const.token_ids[token]
+ residue.append(token)
+ if count > 0:
+ deletion.append((res_idx, count))
+ count = 0
+ res_idx += 1
+
+ res_start = len(residues)
+ res_end = res_start + len(residue)
+
+ del_start = len(deletions)
+ del_end = del_start + len(deletion)
+
+ sequences.append((seq_idx, taxonomy_id, res_start, res_end, del_start, del_end))
+ residues.extend(residue)
+ deletions.extend(deletion)
+
+ seq_idx += 1
+ if (max_seqs is not None) and (seq_idx >= max_seqs):
+ break
+
+ # Create MSA object
+ msa = MSA(
+ residues=np.array(residues, dtype=MSAResidue),
+ deletions=np.array(deletions, dtype=MSADeletion),
+ sequences=np.array(sequences, dtype=MSASequence),
+ )
+ return msa
diff --git a/forks/boltz/src/boltz/data/parse/fasta.py b/forks/boltz/src/boltz/data/parse/fasta.py
new file mode 100644
index 00000000..114cf984
--- /dev/null
+++ b/forks/boltz/src/boltz/data/parse/fasta.py
@@ -0,0 +1,138 @@
+from collections.abc import Mapping
+from pathlib import Path
+
+from Bio import SeqIO
+from rdkit.Chem.rdchem import Mol
+
+from boltz.data.parse.yaml import parse_boltz_schema
+from boltz.data.types import Target
+
+
+def parse_fasta( # noqa: C901, PLR0912
+ path: Path,
+ ccd: Mapping[str, Mol],
+ mol_dir: Path,
+ boltz2: bool = False,
+) -> Target:
+ """Parse a fasta file.
+
+ The name of the fasta file is used as the name of this job.
+ We rely on the fasta record id to determine the entity type.
+
+ > CHAIN_ID|ENTITY_TYPE|MSA_ID
+ SEQUENCE
+ > CHAIN_ID|ENTITY_TYPE|MSA_ID
+ ...
+
+ Where ENTITY_TYPE is either protein, rna, dna, ccd or smiles,
+ and CHAIN_ID is the chain identifier, which should be unique.
+ The MSA_ID is optional and should only be used on proteins.
+
+ Parameters
+ ----------
+ fasta_file : Path
+ Path to the fasta file.
+ ccd : Dict
+ Dictionary of CCD components.
+ mol_dir : Path
+ Path to the directory containing the molecules.
+ boltz2 : bool
+ Whether to parse the input for Boltz2.
+
+ Returns
+ -------
+ Target
+ The parsed target.
+
+ """
+ # Read fasta file
+ with path.open("r") as f:
+ records = list(SeqIO.parse(f, "fasta"))
+
+ # Make sure all records have a chain id and entity
+ for seq_record in records:
+ if "|" not in seq_record.id:
+ msg = f"Invalid record id: {seq_record.id}"
+ raise ValueError(msg)
+
+ header = seq_record.id.split("|")
+ assert len(header) >= 2, f"Invalid record id: {seq_record.id}"
+
+ chain_id, entity_type = header[:2]
+ if entity_type.lower() not in {"protein", "dna", "rna", "ccd", "smiles"}:
+ msg = f"Invalid entity type: {entity_type}"
+ raise ValueError(msg)
+ if chain_id == "":
+ msg = "Empty chain id in input fasta!"
+ raise ValueError(msg)
+ if entity_type == "":
+ msg = "Empty entity type in input fasta!"
+ raise ValueError(msg)
+
+ # Convert to yaml format
+ sequences = []
+ for seq_record in records:
+ # Get chain id, entity type and sequence
+ header = seq_record.id.split("|")
+ chain_id, entity_type = header[:2]
+ if len(header) == 3 and header[2] != "":
+ assert entity_type.lower() == "protein", (
+ "MSA_ID is only allowed for proteins"
+ )
+ msa_id = header[2]
+ else:
+ msa_id = None
+
+ entity_type = entity_type.upper()
+ seq = str(seq_record.seq)
+
+ if entity_type == "PROTEIN":
+ molecule = {
+ "protein": {
+ "id": chain_id,
+ "sequence": seq,
+ "modifications": [],
+ "msa": msa_id,
+ },
+ }
+ elif entity_type == "RNA":
+ molecule = {
+ "rna": {
+ "id": chain_id,
+ "sequence": seq,
+ "modifications": [],
+ },
+ }
+ elif entity_type == "DNA":
+ molecule = {
+ "dna": {
+ "id": chain_id,
+ "sequence": seq,
+ "modifications": [],
+ }
+ }
+ elif entity_type.upper() == "CCD":
+ molecule = {
+ "ligand": {
+ "id": chain_id,
+ "ccd": seq,
+ }
+ }
+ elif entity_type.upper() == "SMILES":
+ molecule = {
+ "ligand": {
+ "id": chain_id,
+ "smiles": seq,
+ }
+ }
+
+ sequences.append(molecule)
+
+ data = {
+ "sequences": sequences,
+ "bonds": [],
+ "version": 1,
+ }
+
+ name = path.stem
+ return parse_boltz_schema(name, data, ccd, mol_dir, boltz2)
diff --git a/forks/boltz/src/boltz/data/parse/mmcif.py b/forks/boltz/src/boltz/data/parse/mmcif.py
new file mode 100644
index 00000000..cade3c2d
--- /dev/null
+++ b/forks/boltz/src/boltz/data/parse/mmcif.py
@@ -0,0 +1,1239 @@
+import contextlib
+from collections import defaultdict
+from dataclasses import dataclass, replace
+from typing import Optional
+
+import gemmi
+import numpy as np
+from rdkit import rdBase
+from rdkit.Chem import AllChem
+from rdkit.Chem.rdchem import Mol
+from sklearn.neighbors import KDTree
+
+from boltz.data import const
+from boltz.data.mol import load_molecules
+from boltz.data.types import (
+ AtomV2,
+ BondV2,
+ Chain,
+ Coords,
+ Ensemble,
+ Interface,
+ Residue,
+ StructureInfo,
+ StructureV2,
+)
+
+####################################################################################################
+# DATACLASSES
+####################################################################################################
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedAtom:
+ """A parsed atom object."""
+
+ name: str
+ coords: tuple[float, float, float]
+ is_present: bool
+ bfactor: float
+ plddt: Optional[float] = None
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedBond:
+ """A parsed bond object."""
+
+ atom_1: int
+ atom_2: int
+ type: int
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedResidue:
+ """A parsed residue object."""
+
+ name: str
+ type: int
+ idx: int
+ atoms: list[ParsedAtom]
+ bonds: list[ParsedBond]
+ orig_idx: Optional[int]
+ atom_center: int
+ atom_disto: int
+ is_standard: bool
+ is_present: bool
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedChain:
+ """A parsed chain object."""
+
+ name: str
+ entity: str
+ type: int
+ residues: list[ParsedResidue]
+ sequence: Optional[str] = None
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedConnection:
+ """A parsed connection object."""
+
+ chain_1: str
+ chain_2: str
+ residue_index_1: int
+ residue_index_2: int
+ atom_index_1: str
+ atom_index_2: str
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedStructure:
+ """A parsed structure object."""
+
+ data: StructureV2
+ info: StructureInfo
+ sequences: dict[str, str]
+
+
+####################################################################################################
+# HELPERS
+####################################################################################################
+
+
+def get_mol(ccd: str, mols: dict, moldir: str) -> Mol:
+ """Get mol from CCD code.
+
+ Return mol with ccd from mols if it is in mols. Otherwise load it from moldir,
+ add it to mols, and return the mol.
+ """
+ mol = mols.get(ccd)
+ if mol is None:
+ # Load molecule
+ mol = load_molecules(moldir, [ccd])[ccd]
+
+ # Add to resource
+ if isinstance(mols, dict):
+ mols[ccd] = mol
+ else:
+ mols.set(ccd, mol)
+
+ return mol
+
+
+def get_dates(block: gemmi.cif.Block) -> tuple[str, str, str]:
+ """Get the deposited, released, and last revision dates.
+
+ Parameters
+ ----------
+ block : gemmi.cif.Block
+ The block to process.
+
+ Returns
+ -------
+ str
+ The deposited date.
+ str
+ The released date.
+ str
+ The last revision date.
+
+ """
+ deposited = "_pdbx_database_status.recvd_initial_deposition_date"
+ revision = "_pdbx_audit_revision_history.revision_date"
+ deposit_date = revision_date = release_date = ""
+ with contextlib.suppress(Exception):
+ deposit_date = block.find([deposited])[0][0]
+ release_date = block.find([revision])[0][0]
+ revision_date = block.find([revision])[-1][0]
+
+ return deposit_date, release_date, revision_date
+
+
+def get_resolution(block: gemmi.cif.Block) -> float:
+ """Get the resolution from a gemmi structure.
+
+ Parameters
+ ----------
+ block : gemmi.cif.Block
+ The block to process.
+
+ Returns
+ -------
+ float
+ The resolution.
+
+ """
+ resolution = 0.0
+ for res_key in (
+ "_refine.ls_d_res_high",
+ "_em_3d_reconstruction.resolution",
+ "_reflns.d_resolution_high",
+ ):
+ with contextlib.suppress(Exception):
+ resolution = float(block.find([res_key])[0].str(0))
+ break
+ return resolution
+
+
+def get_method(block: gemmi.cif.Block) -> str:
+ """Get the method from a gemmi structure.
+
+ Parameters
+ ----------
+ block : gemmi.cif.Block
+ The block to process.
+
+ Returns
+ -------
+ str
+ The method.
+
+ """
+ method = ""
+ method_key = "_exptl.method"
+ with contextlib.suppress(Exception):
+ methods = block.find([method_key])
+ method = ",".join([m.str(0).lower() for m in methods])
+
+ return method
+
+
+def get_experiment_conditions(
+ block: gemmi.cif.Block,
+) -> tuple[Optional[float], Optional[float]]:
+ """Get temperature and pH.
+
+ Parameters
+ ----------
+ block : gemmi.cif.Block
+ The block to process.
+
+ Returns
+ -------
+ tuple[float, float]
+ The temperature and pH.
+ """
+ temperature = None
+ ph = None
+
+ keys_t = [
+ "_exptl_crystal_grow.temp",
+ "_pdbx_nmr_exptl_sample_conditions.temperature",
+ ]
+ for key in keys_t:
+ with contextlib.suppress(Exception):
+ temperature = float(block.find([key])[0][0])
+ break
+
+ keys_ph = ["_exptl_crystal_grow.pH", "_pdbx_nmr_exptl_sample_conditions.pH"]
+ with contextlib.suppress(Exception):
+ for key in keys_ph:
+ ph = float(block.find([key])[0][0])
+ break
+
+ return temperature, ph
+
+
+def get_unk_token(dtype: gemmi.PolymerType) -> str:
+ """Get the unknown token for a given entity type.
+
+ Parameters
+ ----------
+ dtype : gemmi.EntityType
+ The entity type.
+
+ Returns
+ -------
+ str
+ The unknown token.
+
+ """
+ if dtype == gemmi.PolymerType.PeptideL:
+ unk = const.unk_token["PROTEIN"]
+ elif dtype == gemmi.PolymerType.Dna:
+ unk = const.unk_token["DNA"]
+ elif dtype == gemmi.PolymerType.Rna:
+ unk = const.unk_token["RNA"]
+ else:
+ msg = f"Unknown polymer type: {dtype}"
+ raise ValueError(msg)
+
+ return unk
+
+
+def compute_covalent_ligands(
+ connections: list[gemmi.Connection],
+ subchain_map: dict[tuple[str, int], str],
+ entities: dict[str, gemmi.Entity],
+) -> set[str]:
+ """Compute the covalent ligands from a list of connections.
+
+ Parameters
+ ----------
+ connections: list[gemmi.Connection]
+ The connections to process.
+ subchain_map: dict[tuple[str, int], str]
+ The mapping from chain, residue index to subchain name.
+ entities: dict[str, gemmi.Entity]
+ The entities in the structure.
+
+ Returns
+ -------
+ set
+ The covalent ligand subchains.
+
+ """
+ # Get covalent chain ids
+ covalent_chain_ids = set()
+ for connection in connections:
+ if connection.type.name != "Covale":
+ continue
+
+ # Map to correct subchain
+ chain_1_name = connection.partner1.chain_name
+ chain_2_name = connection.partner2.chain_name
+
+ res_1_id = connection.partner1.res_id.seqid
+ res_1_id = str(res_1_id.num) + str(res_1_id.icode).strip()
+
+ res_2_id = connection.partner2.res_id.seqid
+ res_2_id = str(res_2_id.num) + str(res_2_id.icode).strip()
+
+ subchain_1 = subchain_map[(chain_1_name, res_1_id)]
+ subchain_2 = subchain_map[(chain_2_name, res_2_id)]
+
+ # If non-polymer or branched, add to set
+ entity_1 = entities[subchain_1].entity_type.name
+ entity_2 = entities[subchain_2].entity_type.name
+
+ if entity_1 in {"NonPolymer", "Branched"}:
+ covalent_chain_ids.add(subchain_1)
+ if entity_2 in {"NonPolymer", "Branched"}:
+ covalent_chain_ids.add(subchain_2)
+
+ return covalent_chain_ids
+
+
+def compute_interfaces(atom_data: np.ndarray, chain_data: np.ndarray) -> np.ndarray:
+ """Compute the chain-chain interfaces from a gemmi structure.
+
+ Parameters
+ ----------
+ atom_data : list[tuple]
+ The atom data.
+ chain_data : list[tuple]
+ The chain data.
+
+ Returns
+ -------
+ list[tuple[int, int]]
+ The interfaces.
+
+ """
+ # Compute chain_id per atom
+ chain_ids = []
+ for idx, chain in enumerate(chain_data):
+ chain_ids.extend([idx] * chain["atom_num"])
+ chain_ids = np.array(chain_ids)
+
+ # Filter to present atoms
+ coords = atom_data["coords"]
+ mask = atom_data["is_present"]
+
+ coords = coords[mask]
+ chain_ids = chain_ids[mask]
+
+ # Compute the distance matrix
+ tree = KDTree(coords, metric="euclidean")
+ query = tree.query_radius(coords, const.atom_interface_cutoff)
+
+ # Get unique chain pairs
+ interfaces = set()
+ for c1, pairs in zip(chain_ids, query):
+ chains = np.unique(chain_ids[pairs])
+ chains = chains[chains != c1]
+ interfaces.update((c1, c2) for c2 in chains)
+
+ # Get unique chain pairs
+ interfaces = [(min(i, j), max(i, j)) for i, j in interfaces]
+ interfaces = list({(int(i), int(j)) for i, j in interfaces})
+ interfaces = np.array(interfaces, dtype=Interface)
+ return interfaces
+
+
+####################################################################################################
+# PARSING
+####################################################################################################
+
+
+def parse_ccd_residue( # noqa: PLR0915, C901
+ name: str,
+ ref_mol: Mol,
+ res_idx: int,
+ gemmi_mol: Optional[gemmi.Residue] = None,
+ is_covalent: bool = False,
+) -> Optional[ParsedResidue]:
+ """Parse an MMCIF ligand.
+
+ First tries to get the SMILES string from the RCSB.
+ Then, tries to infer atom ordering using RDKit.
+
+ Parameters
+ ----------
+ name: str
+ The name of the molecule to parse.
+ components : dict
+ The preprocessed PDB components dictionary.
+ res_idx : int
+ The residue index.
+ gemmi_mol : Optional[gemmi.Residue]
+ The PDB molecule, as a gemmi Residue object, if any.
+
+ Returns
+ -------
+ ParsedResidue, optional
+ The output ParsedResidue, if successful.
+
+ """
+ # Check if we have a PDB structure for this residue,
+ # it could be a missing residue from the sequence
+ is_present = gemmi_mol is not None
+
+ # Save original index (required for parsing connections)
+ if is_present:
+ orig_idx = gemmi_mol.seqid
+ orig_idx = str(orig_idx.num) + str(orig_idx.icode).strip()
+ else:
+ orig_idx = None
+
+ # Remove hydrogens
+ ref_mol = AllChem.RemoveHs(ref_mol, sanitize=False)
+
+ # Check if this is a single atom CCD residue
+ if ref_mol.GetNumAtoms() == 1:
+ pos = (0, 0, 0)
+ bfactor = 0
+ if is_present:
+ pos = (
+ gemmi_mol[0].pos.x,
+ gemmi_mol[0].pos.y,
+ gemmi_mol[0].pos.z,
+ )
+ bfactor = gemmi_mol[0].b_iso
+ ref_atom = ref_mol.GetAtoms()[0]
+ atom = ParsedAtom(
+ name=ref_atom.GetProp("name"),
+ coords=pos,
+ is_present=is_present,
+ bfactor=bfactor,
+ )
+ unk_prot_id = const.unk_token_ids["PROTEIN"]
+ residue = ParsedResidue(
+ name=name,
+ type=unk_prot_id,
+ atoms=[atom],
+ bonds=[],
+ idx=res_idx,
+ orig_idx=orig_idx,
+ atom_center=0, # Placeholder, no center
+ atom_disto=0, # Placeholder, no center
+ is_standard=False,
+ is_present=is_present,
+ )
+ return residue
+
+ # If multi-atom, start by getting the PDB coordinates
+ pdb_pos = {}
+ bfactor = {}
+ if is_present:
+ # Match atoms based on names
+ for atom in gemmi_mol:
+ atom: gemmi.Atom
+ pos = (atom.pos.x, atom.pos.y, atom.pos.z)
+ pdb_pos[atom.name] = pos
+ bfactor[atom.name] = atom.b_iso
+ # Parse each atom in order of the reference mol
+ atoms = []
+ atom_idx = 0
+ idx_map = {} # Used for bonds later
+
+ for i, atom in enumerate(ref_mol.GetAtoms()):
+ # Get atom name, charge, element and reference coordinates
+ atom_name = atom.GetProp("name")
+
+ # If the atom is a leaving atom, skip if not in the PDB and is_covalent
+ if (
+ atom.HasProp("leaving_atom")
+ and int(atom.GetProp("leaving_atom")) == 1
+ and is_covalent
+ and (atom_name not in pdb_pos)
+ ):
+ continue
+
+ # Get PDB coordinates, if any
+ coords = pdb_pos.get(atom_name)
+ if coords is None:
+ atom_is_present = False
+ coords = (0, 0, 0)
+ else:
+ atom_is_present = True
+
+ # Add atom to list
+ atoms.append(
+ ParsedAtom(
+ name=atom_name,
+ coords=coords,
+ is_present=atom_is_present,
+ bfactor=bfactor.get(atom_name, 0),
+ )
+ )
+ idx_map[i] = atom_idx
+ atom_idx += 1
+
+ # Load bonds
+ bonds = []
+ unk_bond = const.bond_type_ids[const.unk_bond_type]
+ for bond in ref_mol.GetBonds():
+ idx_1 = bond.GetBeginAtomIdx()
+ idx_2 = bond.GetEndAtomIdx()
+
+ # Skip bonds with atoms ignored
+ if (idx_1 not in idx_map) or (idx_2 not in idx_map):
+ continue
+
+ idx_1 = idx_map[idx_1]
+ idx_2 = idx_map[idx_2]
+ start = min(idx_1, idx_2)
+ end = max(idx_1, idx_2)
+ bond_type = bond.GetBondType().name
+ bond_type = const.bond_type_ids.get(bond_type, unk_bond)
+ bonds.append(ParsedBond(start, end, bond_type))
+
+ unk_prot_id = const.unk_token_ids["PROTEIN"]
+ return ParsedResidue(
+ name=name,
+ type=unk_prot_id,
+ atoms=atoms,
+ bonds=bonds,
+ idx=res_idx,
+ atom_center=0,
+ atom_disto=0,
+ orig_idx=orig_idx,
+ is_standard=False,
+ is_present=is_present,
+ )
+
+
+def parse_polymer( # noqa: C901, PLR0915, PLR0912
+ polymer: gemmi.ResidueSpan,
+ polymer_type: gemmi.PolymerType,
+ sequence: list[str],
+ chain_id: str,
+ entity: str,
+ mols: dict[str, Mol],
+ moldir: str,
+) -> Optional[ParsedChain]:
+ """Process a gemmi Polymer into a chain object.
+
+ Performs alignment of the full sequence to the polymer
+ residues. Loads coordinates and masks for the atoms in
+ the polymer, following the ordering in const.atom_order.
+
+ Parameters
+ ----------
+ polymer : gemmi.ResidueSpan
+ The polymer to process.
+ polymer_type : gemmi.PolymerType
+ The polymer type.
+ sequence : str
+ The full sequence of the polymer.
+ chain_id : str
+ The chain identifier.
+ entity : str
+ The entity name.
+ components : dict[str, Mol]
+ The preprocessed PDB components dictionary.
+
+ Returns
+ -------
+ ParsedChain, optional
+ The output chain, if successful.
+
+ Raises
+ ------
+ ValueError
+ If the alignment fails.
+
+ """
+ # Ignore microheterogeneities (pick first)
+ sequence = [gemmi.Entity.first_mon(item) for item in sequence]
+
+ # Align full sequence to polymer residues
+ # This is a simple way to handle all the different numbering schemes
+ result = gemmi.align_sequence_to_polymer(
+ sequence,
+ polymer,
+ polymer_type,
+ gemmi.AlignmentScoring(),
+ )
+
+ # Get coordinates and masks
+ i = 0
+ ref_res = set(const.tokens)
+ parsed = []
+ for j, match in enumerate(result.match_string):
+ # Get residue name from sequence
+ res_name = sequence[j]
+
+ # Check if we have a match in the structure
+ res = None
+ name_to_atom = {}
+
+ if match == "|":
+ # Get pdb residue
+ res = polymer[i]
+ name_to_atom = {a.name.upper(): a for a in res}
+
+ # Double check the match
+ if res.name != res_name:
+ msg = "Alignment mismatch!"
+ raise ValueError(msg)
+
+ # Increment polymer index
+ i += 1
+
+ # Map MSE to MET, put the selenium atom in the sulphur column
+ if res_name == "MSE":
+ res_name = "MET"
+ if "SE" in name_to_atom:
+ name_to_atom["SD"] = name_to_atom["SE"]
+
+ # Handle non-standard residues
+ elif res_name not in ref_res:
+ modified_mol = get_mol(res_name, mols, moldir)
+ if modified_mol is not None:
+ residue = parse_ccd_residue(
+ name=res_name,
+ ref_mol=modified_mol,
+ res_idx=j,
+ gemmi_mol=res,
+ is_covalent=True,
+ )
+ parsed.append(residue)
+ continue
+ else: # noqa: RET507
+ res_name = "UNK"
+
+ # Load regular residues
+ ref_mol = get_mol(res_name, mols, moldir)
+ ref_mol = AllChem.RemoveHs(ref_mol, sanitize=False)
+
+ # Only use reference atoms set in constants
+ ref_name_to_atom = {a.GetProp("name"): a for a in ref_mol.GetAtoms()}
+ ref_atoms = [ref_name_to_atom[a] for a in const.ref_atoms[res_name]]
+
+ # Iterate, always in the same order
+ atoms: list[ParsedAtom] = []
+
+ for ref_atom in ref_atoms:
+ # Get atom name
+ atom_name = ref_atom.GetProp("name")
+
+ # Get coordinates from PDB
+ if atom_name in name_to_atom:
+ atom: gemmi.Atom = name_to_atom[atom_name]
+ atom_is_present = True
+ coords = (atom.pos.x, atom.pos.y, atom.pos.z)
+ bfactor = atom.b_iso
+ else:
+ atom_is_present = False
+ coords = (0, 0, 0)
+ bfactor = 0
+
+ # Add atom to list
+ atoms.append(
+ ParsedAtom(
+ name=atom_name,
+ coords=coords,
+ is_present=atom_is_present,
+ bfactor=bfactor,
+ )
+ )
+
+ # Fix naming errors in arginine residues where NH2 is
+ # incorrectly assigned to be closer to CD than NH1
+ if (res is not None) and (res_name == "ARG"):
+ ref_atoms: list[str] = const.ref_atoms["ARG"]
+ cd = atoms[ref_atoms.index("CD")]
+ nh1 = atoms[ref_atoms.index("NH1")]
+ nh2 = atoms[ref_atoms.index("NH2")]
+
+ cd_coords = np.array(cd.coords)
+ nh1_coords = np.array(nh1.coords)
+ nh2_coords = np.array(nh2.coords)
+
+ if all(atom.is_present for atom in (cd, nh1, nh2)) and (
+ np.linalg.norm(nh1_coords - cd_coords)
+ > np.linalg.norm(nh2_coords - cd_coords)
+ ):
+ atoms[ref_atoms.index("NH1")] = replace(nh1, coords=nh2.coords)
+ atoms[ref_atoms.index("NH2")] = replace(nh2, coords=nh1.coords)
+
+ # Add residue to parsed list
+ if res is not None:
+ orig_idx = res.seqid
+ orig_idx = str(orig_idx.num) + str(orig_idx.icode).strip()
+ else:
+ orig_idx = None
+
+ atom_center = const.res_to_center_atom_id[res_name]
+ atom_disto = const.res_to_disto_atom_id[res_name]
+ parsed.append(
+ ParsedResidue(
+ name=res_name,
+ type=const.token_ids[res_name],
+ atoms=atoms,
+ bonds=[],
+ idx=j,
+ atom_center=atom_center,
+ atom_disto=atom_disto,
+ is_standard=True,
+ is_present=res is not None,
+ orig_idx=orig_idx,
+ )
+ )
+
+ # Get polymer class
+ if polymer_type == gemmi.PolymerType.PeptideL:
+ chain_type = const.chain_type_ids["PROTEIN"]
+ elif polymer_type == gemmi.PolymerType.Dna:
+ chain_type = const.chain_type_ids["DNA"]
+ elif polymer_type == gemmi.PolymerType.Rna:
+ chain_type = const.chain_type_ids["RNA"]
+
+ # Return polymer object
+ return ParsedChain(
+ name=chain_id,
+ entity=entity,
+ residues=parsed,
+ type=chain_type,
+ sequence=gemmi.one_letter_code(sequence),
+ )
+
+
+def parse_connection(
+ connection: gemmi.Connection,
+ chains: list[ParsedChain],
+ subchain_map: dict[tuple[str, int], str],
+) -> ParsedConnection:
+ """Parse (covalent) connection from a gemmi Connection.
+
+ Parameters
+ ----------
+ connections : gemmi.Connectionlist
+ The connection list to parse.
+ chains : list[Chain]
+ The parsed chains.
+ subchain_map : dict[tuple[str, int], str]
+ The mapping from chain, residue index to subchain name.
+
+ Returns
+ -------
+ list[Connection]
+ The parsed connections.
+
+ """
+ # Map to correct subchains
+ chain_1_name = connection.partner1.chain_name
+ chain_2_name = connection.partner2.chain_name
+
+ res_1_id = connection.partner1.res_id.seqid
+ res_1_id = str(res_1_id.num) + str(res_1_id.icode).strip()
+
+ res_2_id = connection.partner2.res_id.seqid
+ res_2_id = str(res_2_id.num) + str(res_2_id.icode).strip()
+
+ subchain_1 = subchain_map[(chain_1_name, res_1_id)]
+ subchain_2 = subchain_map[(chain_2_name, res_2_id)]
+
+ # Get chain indices
+ chain_1 = next(chain for chain in chains if (chain.name == subchain_1))
+ chain_2 = next(chain for chain in chains if (chain.name == subchain_2))
+
+ # Get residue indices
+ res_1_idx, res_1 = next(
+ (idx, res)
+ for idx, res in enumerate(chain_1.residues)
+ if (res.orig_idx == res_1_id)
+ )
+ res_2_idx, res_2 = next(
+ (idx, res)
+ for idx, res in enumerate(chain_2.residues)
+ if (res.orig_idx == res_2_id)
+ )
+
+ # Get atom indices
+ atom_index_1 = next(
+ idx
+ for idx, atom in enumerate(res_1.atoms)
+ if atom.name == connection.partner1.atom_name
+ )
+ atom_index_2 = next(
+ idx
+ for idx, atom in enumerate(res_2.atoms)
+ if atom.name == connection.partner2.atom_name
+ )
+
+ conn = ParsedConnection(
+ chain_1=subchain_1,
+ chain_2=subchain_2,
+ residue_index_1=res_1_idx,
+ residue_index_2=res_2_idx,
+ atom_index_1=atom_index_1,
+ atom_index_2=atom_index_2,
+ )
+
+ return conn
+
+
+def parse_mmcif( # noqa: C901, PLR0915, PLR0912
+ path: str,
+ mols: Optional[dict[str, Mol]] = None,
+ moldir: Optional[str] = None,
+ use_assembly: bool = True,
+ compute_interfaces: bool = True,
+) -> ParsedStructure:
+ """Parse a structure in MMCIF format.
+
+ Parameters
+ ----------
+ mmcif_file : PathLike
+ Path to the MMCIF file.
+ components: Mapping[str, Mol]
+ The preprocessed PDB components dictionary.
+
+ Returns
+ -------
+ ParsedStructure
+ The parsed structure.
+
+ """
+ # Disable rdkit warnings
+ blocker = rdBase.BlockLogs() # noqa: F841
+
+ # set mols
+ mols = {} if mols is None else mols
+
+ # Parse MMCIF input file
+ block = gemmi.cif.read(str(path))[0]
+
+ # Extract medatadata
+ deposit_date, release_date, revision_date = get_dates(block)
+ resolution = get_resolution(block)
+ method = get_method(block)
+ temperature, ph = get_experiment_conditions(block)
+
+ # Load structure object
+ structure = gemmi.make_structure_from_block(block)
+
+ # Clean up the structure
+ structure.merge_chain_parts()
+ structure.remove_waters()
+ structure.remove_hydrogens()
+ structure.remove_alternative_conformations()
+ structure.remove_empty_chains()
+
+ # Expand assembly 1
+ if use_assembly and structure.assemblies:
+ how = gemmi.HowToNameCopiedChain.AddNumber
+ assembly_name = structure.assemblies[0].name
+ structure.transform_to_assembly(assembly_name, how=how)
+
+ # Parse entities
+ # Create mapping from subchain id to entity
+ entities: dict[str, gemmi.Entity] = {}
+ entity_ids: dict[str, int] = {}
+ for entity_id, entity in enumerate(structure.entities):
+ entity: gemmi.Entity
+ if entity.entity_type.name == "Water":
+ continue
+ for subchain_id in entity.subchains:
+ entities[subchain_id] = entity
+ entity_ids[subchain_id] = entity_id
+
+ # Create mapping from chain, residue to subchains
+ # since a Connection uses the chains and not subchins
+ subchain_map = {}
+ for chain in structure[0]:
+ for residue in chain:
+ seq_id = residue.seqid
+ seq_id = str(seq_id.num) + str(seq_id.icode).strip()
+ subchain_map[(chain.name, seq_id)] = residue.subchain
+
+ # Find covalent ligands
+ covalent_chain_ids = compute_covalent_ligands(
+ connections=structure.connections,
+ subchain_map=subchain_map,
+ entities=entities,
+ )
+
+ # Parse chains
+ chains: list[ParsedChain] = []
+ for raw_chain in structure[0].subchains():
+ # Check chain type
+ subchain_id = raw_chain.subchain_id()
+ entity: gemmi.Entity = entities[subchain_id]
+ entity_type = entity.entity_type.name
+
+ # Parse a polymer
+ if entity_type == "Polymer":
+ # Skip PeptideD, DnaRnaHybrid, Pna, Other
+ if entity.polymer_type.name not in {
+ "PeptideL",
+ "Dna",
+ "Rna",
+ }:
+ continue
+
+ # Add polymer if successful
+ parsed_polymer = parse_polymer(
+ polymer=raw_chain,
+ polymer_type=entity.polymer_type,
+ sequence=entity.full_sequence,
+ chain_id=subchain_id,
+ entity=entity.name,
+ mols=mols,
+ moldir=moldir,
+ )
+ if parsed_polymer is not None:
+ chains.append(parsed_polymer)
+
+ # Parse a non-polymer
+ elif entity_type in {"NonPolymer", "Branched"}:
+ # Skip UNL
+ if any(lig.name == "UNL" for lig in raw_chain):
+ continue
+
+ residues = []
+ for lig_idx, ligand in enumerate(raw_chain):
+ # Check if ligand is covalent
+ if entity_type == "Branched":
+ is_covalent = True
+ else:
+ is_covalent = subchain_id in covalent_chain_ids
+
+ ligand: gemmi.Residue
+ ligand_mol = get_mol(ligand.name, mols, moldir)
+
+ residue = parse_ccd_residue(
+ name=ligand.name,
+ ref_mol=ligand_mol,
+ res_idx=lig_idx,
+ gemmi_mol=ligand,
+ is_covalent=is_covalent,
+ )
+ residues.append(residue)
+
+ if residues:
+ chains.append(
+ ParsedChain(
+ name=subchain_id,
+ entity=entity.name,
+ residues=residues,
+ type=const.chain_type_ids["NONPOLYMER"],
+ )
+ )
+
+ # If no chains parsed fail
+ if not chains:
+ msg = "No chains parsed!"
+ raise ValueError(msg)
+
+ # Want to traverse subchains in same order as reference structure
+ ref_chain_map = {ref_chain.name: i for i, ref_chain in enumerate(chains)}
+ all_ensembles = [chains]
+
+ # Loop through different structures in model
+ for struct in list(structure)[1:]:
+ struct: gemmi.Model
+ ensemble_chains = {}
+
+ for raw_chain in struct.subchains():
+ # Check chain type
+ subchain_id = raw_chain.subchain_id()
+ entity: gemmi.Entity = entities[subchain_id]
+ entity_type = entity.entity_type.name
+
+ # Parse a polymer
+ if entity_type == "Polymer":
+ # Skip PeptideD, DnaRnaHybrid, Pna, Other
+ if entity.polymer_type.name not in {
+ "PeptideL",
+ "Dna",
+ "Rna",
+ }:
+ continue
+
+ # Add polymer if successful
+ parsed_polymer = parse_polymer(
+ polymer=raw_chain,
+ polymer_type=entity.polymer_type,
+ sequence=entity.full_sequence,
+ chain_id=subchain_id,
+ entity=entity.name,
+ mols=mols,
+ moldir=moldir,
+ )
+ if parsed_polymer is not None:
+ ensemble_chains[ref_chain_map[subchain_id]] = parsed_polymer
+
+ # Parse a non-polymer
+ elif entity_type in {"NonPolymer", "Branched"}:
+ # Skip UNL
+ if any(lig.name == "UNL" for lig in raw_chain):
+ continue
+
+ residues = []
+ for lig_idx, ligand in enumerate(raw_chain):
+ # Check if ligand is covalent
+ if entity_type == "Branched":
+ is_covalent = True
+ else:
+ is_covalent = subchain_id in covalent_chain_ids
+
+ ligand: gemmi.Residue
+ ligand_mol = get_mol(ligand.name, mols, moldir)
+
+ residue = parse_ccd_residue(
+ name=ligand.name,
+ ref_mol=ligand_mol,
+ res_idx=lig_idx,
+ gemmi_mol=ligand,
+ is_covalent=is_covalent,
+ )
+ residues.append(residue)
+
+ if residues:
+ parsed_non_polymer = ParsedChain(
+ name=subchain_id,
+ entity=entity.name,
+ residues=residues,
+ type=const.chain_type_ids["NONPOLYMER"],
+ )
+ ensemble_chains[ref_chain_map[subchain_id]] = parsed_non_polymer
+
+ # Ensure ensemble chains are in the same order as reference structure
+ ensemble_chains = [ensemble_chains[idx] for idx in range(len(ensemble_chains))]
+ all_ensembles.append(ensemble_chains)
+
+ # Parse covalent connections
+ connections: list[ParsedConnection] = []
+ for connection in structure.connections:
+ # Skip non-covalent connections
+ connection: gemmi.Connection
+ if connection.type.name != "Covale":
+ continue
+ try:
+ parsed_connection = parse_connection(
+ connection=connection,
+ chains=chains,
+ subchain_map=subchain_map,
+ )
+ except Exception: # noqa: S112, BLE001
+ continue
+ connections.append(parsed_connection)
+
+ # Create tables
+ atom_data = []
+ bond_data = []
+ res_data = []
+ chain_data = []
+ ensemble_data = []
+ coords_data = defaultdict(list)
+
+ # Convert parsed chains to tables
+ atom_idx = 0
+ res_idx = 0
+ sym_count = {}
+ chain_to_idx = {}
+ res_to_idx = {}
+ chain_to_seq = {}
+
+ for asym_id, chain in enumerate(chains):
+ # Compute number of atoms and residues
+ res_num = len(chain.residues)
+ atom_num = sum(len(res.atoms) for res in chain.residues)
+
+ # Get same chain across models in ensemble
+ ensemble_chains = [ensemble[asym_id] for ensemble in all_ensembles]
+ assert len(ensemble_chains) == len(all_ensembles)
+ for ensemble_chain in ensemble_chains:
+ assert len(ensemble_chain.residues) == res_num
+ assert sum(len(res.atoms) for res in ensemble_chain.residues) == atom_num
+
+ # Find all copies of this chain in the assembly
+ entity_id = entity_ids[chain.name]
+ sym_id = sym_count.get(entity_id, 0)
+ chain_data.append(
+ (
+ chain.name,
+ chain.type,
+ entity_id,
+ sym_id,
+ asym_id,
+ atom_idx,
+ atom_num,
+ res_idx,
+ res_num,
+ 0,
+ )
+ )
+ chain_to_idx[chain.name] = asym_id
+ sym_count[entity_id] = sym_id + 1
+ if chain.sequence is not None:
+ chain_to_seq[chain.name] = chain.sequence
+
+ # Add residue, atom, bond, data
+ for i, res in enumerate(chain.residues):
+ # Get same residue across models in ensemble
+ ensemble_residues = [
+ ensemble_chain.residues[i] for ensemble_chain in ensemble_chains
+ ]
+ assert len(ensemble_residues) == len(all_ensembles)
+ for ensemble_res in ensemble_residues:
+ assert ensemble_res.name == res.name
+
+ atom_center = atom_idx + res.atom_center
+ atom_disto = atom_idx + res.atom_disto
+ res_data.append(
+ (
+ res.name,
+ res.type,
+ res.idx,
+ atom_idx,
+ len(res.atoms),
+ atom_center,
+ atom_disto,
+ res.is_standard,
+ res.is_present,
+ )
+ )
+ res_to_idx[(chain.name, i)] = (res_idx, atom_idx)
+
+ for bond in res.bonds:
+ chain_1 = asym_id
+ chain_2 = asym_id
+ res_1 = res_idx
+ res_2 = res_idx
+ atom_1 = atom_idx + bond.atom_1
+ atom_2 = atom_idx + bond.atom_2
+ bond_data.append(
+ (
+ chain_1,
+ chain_2,
+ res_1,
+ res_2,
+ atom_1,
+ atom_2,
+ bond.type,
+ )
+ )
+
+ for a_idx, atom in enumerate(res.atoms):
+ # Get same atom across models in ensemble
+ ensemble_atoms = [
+ ensemble_res.atoms[a_idx] for ensemble_res in ensemble_residues
+ ]
+ assert len(ensemble_atoms) == len(all_ensembles)
+ for e_idx, ensemble_atom in enumerate(ensemble_atoms):
+ assert ensemble_atom.name == atom.name
+ assert atom.is_present == ensemble_atom.is_present
+
+ coords_data[e_idx].append(ensemble_atom.coords)
+
+ atom_data.append(
+ (
+ atom.name,
+ atom.coords,
+ atom.is_present,
+ atom.bfactor,
+ 1.0, # plddt is 1 for real data
+ )
+ )
+ atom_idx += 1
+
+ res_idx += 1
+
+ # Create coordinates table
+ coords_data_ = []
+ for e_idx in range(len(coords_data)):
+ ensemble_data.append((e_idx * atom_idx, atom_idx))
+ coords_data_.append(coords_data[e_idx])
+ coords_data = [(x,) for xs in coords_data_ for x in xs]
+
+ # Convert connections to tables
+ for conn in connections:
+ chain_1_idx = chain_to_idx[conn.chain_1]
+ chain_2_idx = chain_to_idx[conn.chain_2]
+ res_1_idx, atom_1_offset = res_to_idx[(conn.chain_1, conn.residue_index_1)]
+ res_2_idx, atom_2_offset = res_to_idx[(conn.chain_2, conn.residue_index_2)]
+ atom_1_idx = atom_1_offset + conn.atom_index_1
+ atom_2_idx = atom_2_offset + conn.atom_index_2
+ bond_data.append(
+ (
+ chain_1_idx,
+ chain_2_idx,
+ res_1_idx,
+ res_2_idx,
+ atom_1_idx,
+ atom_2_idx,
+ const.bond_type_ids["COVALENT"],
+ )
+ )
+
+ # Convert into datatypes
+ atoms = np.array(atom_data, dtype=AtomV2)
+ bonds = np.array(bond_data, dtype=BondV2)
+ residues = np.array(res_data, dtype=Residue)
+ chains = np.array(chain_data, dtype=Chain)
+ mask = np.ones(len(chain_data), dtype=bool)
+ ensemble = np.array(ensemble_data, dtype=Ensemble)
+ coords = np.array(coords_data, dtype=Coords)
+
+ # Compute interface chains (find chains with a heavy atom within 5A)
+ if compute_interfaces:
+ interfaces = compute_interfaces(atoms, chains)
+ else:
+ interfaces = np.array([], dtype=Interface)
+
+ # Return parsed structure
+ info = StructureInfo(
+ deposited=deposit_date,
+ revised=revision_date,
+ released=release_date,
+ resolution=resolution,
+ method=method,
+ num_chains=len(chains),
+ num_interfaces=len(interfaces),
+ temperature=temperature,
+ pH=ph,
+ )
+
+ data = StructureV2(
+ atoms=atoms,
+ bonds=bonds,
+ residues=residues,
+ chains=chains,
+ interfaces=interfaces,
+ mask=mask,
+ ensemble=ensemble,
+ coords=coords,
+ )
+
+ return ParsedStructure(
+ data=data,
+ info=info,
+ sequences=chain_to_seq,
+ )
diff --git a/forks/boltz/src/boltz/data/parse/mmcif_with_constraints.py b/forks/boltz/src/boltz/data/parse/mmcif_with_constraints.py
new file mode 100644
index 00000000..6a5b0409
--- /dev/null
+++ b/forks/boltz/src/boltz/data/parse/mmcif_with_constraints.py
@@ -0,0 +1,1607 @@
+import contextlib
+from collections import defaultdict
+from dataclasses import dataclass, replace
+from typing import Optional
+
+import gemmi
+import numpy as np
+from rdkit import Chem, rdBase
+from rdkit.Chem import AllChem, HybridizationType
+from rdkit.Chem.rdchem import BondStereo, Mol
+from rdkit.Chem.rdDistGeom import GetMoleculeBoundsMatrix
+from rdkit.Chem.rdMolDescriptors import CalcNumHeavyAtoms
+from sklearn.neighbors import KDTree
+
+from boltz.data import const
+from boltz.data.mol import load_molecules
+from boltz.data.types import (
+ AtomV2,
+ BondV2,
+ Chain,
+ ChiralAtomConstraint,
+ Coords,
+ Ensemble,
+ Interface,
+ PlanarBondConstraint,
+ PlanarRing5Constraint,
+ PlanarRing6Constraint,
+ RDKitBoundsConstraint,
+ Residue,
+ ResidueConstraints,
+ StereoBondConstraint,
+ StructureInfo,
+ StructureV2,
+)
+
+####################################################################################################
+# DATACLASSES
+####################################################################################################
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedAtom:
+ """A parsed atom object."""
+
+ name: str
+ coords: tuple[float, float, float]
+ is_present: bool
+ bfactor: float
+ plddt: Optional[float] = None
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedBond:
+ """A parsed bond object."""
+
+ atom_1: int
+ atom_2: int
+ type: int
+
+
+@dataclass(frozen=True)
+class ParsedRDKitBoundsConstraint:
+ """A parsed RDKit bounds constraint object."""
+
+ atom_idxs: tuple[int, int]
+ is_bond: bool
+ is_angle: bool
+ upper_bound: float
+ lower_bound: float
+
+
+@dataclass(frozen=True)
+class ParsedChiralAtomConstraint:
+ """A parsed chiral atom constraint object."""
+
+ atom_idxs: tuple[int, int, int, int]
+ is_reference: bool
+ is_r: bool
+
+
+@dataclass(frozen=True)
+class ParsedStereoBondConstraint:
+ """A parsed stereo bond constraint object."""
+
+ atom_idxs: tuple[int, int, int, int]
+ is_check: bool
+ is_e: bool
+
+
+@dataclass(frozen=True)
+class ParsedPlanarBondConstraint:
+ """A parsed planar bond constraint object."""
+
+ atom_idxs: tuple[int, int, int, int, int, int]
+
+
+@dataclass(frozen=True)
+class ParsedPlanarRing5Constraint:
+ """A parsed planar bond constraint object."""
+
+ atom_idxs: tuple[int, int, int, int, int]
+
+
+@dataclass(frozen=True)
+class ParsedPlanarRing6Constraint:
+ """A parsed planar bond constraint object."""
+
+ atom_idxs: tuple[int, int, int, int, int, int]
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedResidue:
+ """A parsed residue object."""
+
+ name: str
+ type: int
+ idx: int
+ atoms: list[ParsedAtom]
+ bonds: list[ParsedBond]
+ orig_idx: Optional[int]
+ atom_center: int
+ atom_disto: int
+ is_standard: bool
+ is_present: bool
+ rdkit_bounds_constraints: Optional[list[ParsedRDKitBoundsConstraint]] = None
+ chiral_atom_constraints: Optional[list[ParsedChiralAtomConstraint]] = None
+ stereo_bond_constraints: Optional[list[ParsedStereoBondConstraint]] = None
+ planar_bond_constraints: Optional[list[ParsedPlanarBondConstraint]] = None
+ planar_ring_5_constraints: Optional[list[ParsedPlanarRing5Constraint]] = None
+ planar_ring_6_constraints: Optional[list[ParsedPlanarRing6Constraint]] = None
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedChain:
+ """A parsed chain object."""
+
+ name: str
+ entity: str
+ type: int
+ residues: list[ParsedResidue]
+ sequence: Optional[str] = None
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedConnection:
+ """A parsed connection object."""
+
+ chain_1: str
+ chain_2: str
+ residue_index_1: int
+ residue_index_2: int
+ atom_index_1: str
+ atom_index_2: str
+
+
+@dataclass(frozen=True, slots=True)
+class ParsedStructure:
+ """A parsed structure object."""
+
+ data: StructureV2
+ info: StructureInfo
+ sequences: dict[str, str]
+ residue_constraints: Optional[ResidueConstraints] = None
+
+
+####################################################################################################
+# HELPERS
+####################################################################################################
+
+
+def get_mol(ccd: str, mols: dict, moldir: str) -> Mol:
+ """Get mol from CCD code.
+
+ Return mol with ccd from mols if it is in mols. Otherwise load it from moldir,
+ add it to mols, and return the mol.
+ """
+ mol = mols.get(ccd)
+ if mol is None:
+ # Load molecule
+ mol = load_molecules(moldir, [ccd])[ccd]
+
+ # Add to resource
+ if isinstance(mols, dict):
+ mols[ccd] = mol
+ else:
+ mols.set(ccd, mol)
+
+ return mol
+
+
+def get_dates(block: gemmi.cif.Block) -> tuple[str, str, str]:
+ """Get the deposited, released, and last revision dates.
+
+ Parameters
+ ----------
+ block : gemmi.cif.Block
+ The block to process.
+
+ Returns
+ -------
+ str
+ The deposited date.
+ str
+ The released date.
+ str
+ The last revision date.
+
+ """
+ deposited = "_pdbx_database_status.recvd_initial_deposition_date"
+ revision = "_pdbx_audit_revision_history.revision_date"
+ deposit_date = revision_date = release_date = ""
+ with contextlib.suppress(Exception):
+ deposit_date = block.find([deposited])[0][0]
+ release_date = block.find([revision])[0][0]
+ revision_date = block.find([revision])[-1][0]
+
+ return deposit_date, release_date, revision_date
+
+
+def get_resolution(block: gemmi.cif.Block) -> float:
+ """Get the resolution from a gemmi structure.
+
+ Parameters
+ ----------
+ block : gemmi.cif.Block
+ The block to process.
+
+ Returns
+ -------
+ float
+ The resolution.
+
+ """
+ resolution = 0.0
+ for res_key in (
+ "_refine.ls_d_res_high",
+ "_em_3d_reconstruction.resolution",
+ "_reflns.d_resolution_high",
+ ):
+ with contextlib.suppress(Exception):
+ resolution = float(block.find([res_key])[0].str(0))
+ break
+ return resolution
+
+
+def get_method(block: gemmi.cif.Block) -> str:
+ """Get the method from a gemmi structure.
+
+ Parameters
+ ----------
+ block : gemmi.cif.Block
+ The block to process.
+
+ Returns
+ -------
+ str
+ The method.
+
+ """
+ method = ""
+ method_key = "_exptl.method"
+ with contextlib.suppress(Exception):
+ methods = block.find([method_key])
+ method = ",".join([m.str(0).lower() for m in methods])
+
+ return method
+
+
+def get_experiment_conditions(
+ block: gemmi.cif.Block,
+) -> tuple[Optional[float], Optional[float]]:
+ """Get temperature and pH.
+
+ Parameters
+ ----------
+ block : gemmi.cif.Block
+ The block to process.
+
+ Returns
+ -------
+ tuple[float, float]
+ The temperature and pH.
+ """
+ temperature = None
+ ph = None
+
+ keys_t = [
+ "_exptl_crystal_grow.temp",
+ "_pdbx_nmr_exptl_sample_conditions.temperature",
+ ]
+ for key in keys_t:
+ with contextlib.suppress(Exception):
+ temperature = float(block.find([key])[0][0])
+ break
+
+ keys_ph = ["_exptl_crystal_grow.pH", "_pdbx_nmr_exptl_sample_conditions.pH"]
+ with contextlib.suppress(Exception):
+ for key in keys_ph:
+ ph = float(block.find([key])[0][0])
+ break
+
+ return temperature, ph
+
+
+def get_unk_token(dtype: gemmi.PolymerType) -> str:
+ """Get the unknown token for a given entity type.
+
+ Parameters
+ ----------
+ dtype : gemmi.EntityType
+ The entity type.
+
+ Returns
+ -------
+ str
+ The unknown token.
+
+ """
+ if dtype == gemmi.PolymerType.PeptideL:
+ unk = const.unk_token["PROTEIN"]
+ elif dtype == gemmi.PolymerType.Dna:
+ unk = const.unk_token["DNA"]
+ elif dtype == gemmi.PolymerType.Rna:
+ unk = const.unk_token["RNA"]
+ else:
+ msg = f"Unknown polymer type: {dtype}"
+ raise ValueError(msg)
+
+ return unk
+
+
+def compute_covalent_ligands(
+ connections: list[gemmi.Connection],
+ subchain_map: dict[tuple[str, int], str],
+ entities: dict[str, gemmi.Entity],
+) -> set[str]:
+ """Compute the covalent ligands from a list of connections.
+
+ Parameters
+ ----------
+ connections: list[gemmi.Connection]
+ The connections to process.
+ subchain_map: dict[tuple[str, int], str]
+ The mapping from chain, residue index to subchain name.
+ entities: dict[str, gemmi.Entity]
+ The entities in the structure.
+
+ Returns
+ -------
+ set
+ The covalent ligand subchains.
+
+ """
+ # Get covalent chain ids
+ covalent_chain_ids = set()
+ for connection in connections:
+ if connection.type.name != "Covale":
+ continue
+
+ # Map to correct subchain
+ chain_1_name = connection.partner1.chain_name
+ chain_2_name = connection.partner2.chain_name
+
+ res_1_id = connection.partner1.res_id.seqid
+ res_1_id = str(res_1_id.num) + str(res_1_id.icode).strip()
+
+ res_2_id = connection.partner2.res_id.seqid
+ res_2_id = str(res_2_id.num) + str(res_2_id.icode).strip()
+
+ subchain_1 = subchain_map[(chain_1_name, res_1_id)]
+ subchain_2 = subchain_map[(chain_2_name, res_2_id)]
+
+ # If non-polymer or branched, add to set
+ entity_1 = entities[subchain_1].entity_type.name
+ entity_2 = entities[subchain_2].entity_type.name
+
+ if entity_1 in {"NonPolymer", "Branched"}:
+ covalent_chain_ids.add(subchain_1)
+ if entity_2 in {"NonPolymer", "Branched"}:
+ covalent_chain_ids.add(subchain_2)
+
+ return covalent_chain_ids
+
+
+def compute_interfaces(atom_data: np.ndarray, chain_data: np.ndarray) -> np.ndarray:
+ """Compute the chain-chain interfaces from a gemmi structure.
+
+ Parameters
+ ----------
+ atom_data : list[tuple]
+ The atom data.
+ chain_data : list[tuple]
+ The chain data.
+
+ Returns
+ -------
+ list[tuple[int, int]]
+ The interfaces.
+
+ """
+ # Compute chain_id per atom
+ chain_ids = []
+ for idx, chain in enumerate(chain_data):
+ chain_ids.extend([idx] * chain["atom_num"])
+ chain_ids = np.array(chain_ids)
+
+ # Filter to present atoms
+ coords = atom_data["coords"]
+ mask = atom_data["is_present"]
+
+ coords = coords[mask]
+ chain_ids = chain_ids[mask]
+
+ # Compute the distance matrix
+ tree = KDTree(coords, metric="euclidean")
+ query = tree.query_radius(coords, const.atom_interface_cutoff)
+
+ # Get unique chain pairs
+ interfaces = set()
+ for c1, pairs in zip(chain_ids, query):
+ chains = np.unique(chain_ids[pairs])
+ chains = chains[chains != c1]
+ interfaces.update((c1, c2) for c2 in chains)
+
+ # Get unique chain pairs
+ interfaces = [(min(i, j), max(i, j)) for i, j in interfaces]
+ interfaces = list({(int(i), int(j)) for i, j in interfaces})
+ interfaces = np.array(interfaces, dtype=Interface)
+ return interfaces
+
+
+####################################################################################################
+# CONSTRAINTS
+####################################################################################################
+
+
+def compute_geometry_constraints(mol: Mol, idx_map):
+ if mol.GetNumAtoms() <= 1:
+ return []
+
+ bounds = GetMoleculeBoundsMatrix(
+ mol,
+ set15bounds=True,
+ scaleVDW=True,
+ doTriangleSmoothing=True,
+ useMacrocycle14config=False,
+ )
+ bonds = set(
+ tuple(sorted(b)) for b in mol.GetSubstructMatches(Chem.MolFromSmarts("*~*"))
+ )
+ angles = set(
+ tuple(sorted([a[0], a[2]]))
+ for a in mol.GetSubstructMatches(Chem.MolFromSmarts("*~*~*"))
+ )
+
+ constraints = []
+ for i, j in zip(*np.triu_indices(mol.GetNumAtoms(), k=1)):
+ if i in idx_map and j in idx_map:
+ constraint = ParsedRDKitBoundsConstraint(
+ atom_idxs=(idx_map[i], idx_map[j]),
+ is_bond=tuple(sorted([i, j])) in bonds,
+ is_angle=tuple(sorted([i, j])) in angles,
+ upper_bound=bounds[i, j],
+ lower_bound=bounds[j, i],
+ )
+ constraints.append(constraint)
+ return constraints
+
+
+def compute_chiral_atom_constraints(mol, idx_map):
+ constraints = []
+ if all([atom.HasProp("_CIPRank") for atom in mol.GetAtoms()]):
+ for center_idx, orientation in Chem.FindMolChiralCenters(
+ mol, includeUnassigned=False
+ ):
+ center = mol.GetAtomWithIdx(center_idx)
+ neighbors = [
+ (neighbor.GetIdx(), int(neighbor.GetProp("_CIPRank")))
+ for neighbor in center.GetNeighbors()
+ ]
+ neighbors = sorted(
+ neighbors, key=lambda neighbor: neighbor[1], reverse=True
+ )
+ neighbors = tuple(neighbor[0] for neighbor in neighbors)
+ is_r = orientation == "R"
+
+ if len(neighbors) > 4 or center.GetHybridization() != HybridizationType.SP3:
+ continue
+
+ atom_idxs = (*neighbors[:3], center_idx)
+ if all(i in idx_map for i in atom_idxs):
+ constraints.append(
+ ParsedChiralAtomConstraint(
+ atom_idxs=tuple(idx_map[i] for i in atom_idxs),
+ is_reference=True,
+ is_r=is_r,
+ )
+ )
+
+ if len(neighbors) == 4:
+ for skip_idx in range(3):
+ chiral_set = neighbors[:skip_idx] + neighbors[skip_idx + 1 :]
+ if skip_idx % 2 == 0:
+ atom_idxs = chiral_set[::-1] + (center_idx,)
+ else:
+ atom_idxs = chiral_set + (center_idx,)
+ if all(i in idx_map for i in atom_idxs):
+ constraints.append(
+ ParsedChiralAtomConstraint(
+ atom_idxs=tuple(idx_map[i] for i in atom_idxs),
+ is_reference=False,
+ is_r=is_r,
+ )
+ )
+ return constraints
+
+
+def compute_stereo_bond_constraints(mol, idx_map):
+ constraints = []
+ if all([atom.HasProp("_CIPRank") for atom in mol.GetAtoms()]):
+ for bond in mol.GetBonds():
+ stereo = bond.GetStereo()
+ if stereo in {BondStereo.STEREOE, BondStereo.STEREOZ}:
+ start_atom_idx, end_atom_idx = (
+ bond.GetBeginAtomIdx(),
+ bond.GetEndAtomIdx(),
+ )
+ start_neighbors = [
+ (neighbor.GetIdx(), int(neighbor.GetProp("_CIPRank")))
+ for neighbor in mol.GetAtomWithIdx(start_atom_idx).GetNeighbors()
+ if neighbor.GetIdx() != end_atom_idx
+ ]
+ start_neighbors = sorted(
+ start_neighbors, key=lambda neighbor: neighbor[1], reverse=True
+ )
+ start_neighbors = [neighbor[0] for neighbor in start_neighbors]
+ end_neighbors = [
+ (neighbor.GetIdx(), int(neighbor.GetProp("_CIPRank")))
+ for neighbor in mol.GetAtomWithIdx(end_atom_idx).GetNeighbors()
+ if neighbor.GetIdx() != start_atom_idx
+ ]
+ end_neighbors = sorted(
+ end_neighbors, key=lambda neighbor: neighbor[1], reverse=True
+ )
+ end_neighbors = [neighbor[0] for neighbor in end_neighbors]
+ is_e = stereo == BondStereo.STEREOE
+
+ atom_idxs = (
+ start_neighbors[0],
+ start_atom_idx,
+ end_atom_idx,
+ end_neighbors[0],
+ )
+ if all(i in idx_map for i in atom_idxs):
+ constraints.append(
+ ParsedStereoBondConstraint(
+ atom_idxs=tuple(idx_map[i] for i in atom_idxs),
+ is_check=True,
+ is_e=is_e,
+ )
+ )
+
+ if len(start_neighbors) == 2 and len(end_neighbors) == 2:
+ atom_idxs = (
+ start_neighbors[1],
+ start_atom_idx,
+ end_atom_idx,
+ end_neighbors[1],
+ )
+ if all(i in idx_map for i in atom_idxs):
+ constraints.append(
+ ParsedStereoBondConstraint(
+ atom_idxs=tuple(idx_map[i] for i in atom_idxs),
+ is_check=False,
+ is_e=is_e,
+ )
+ )
+ return constraints
+
+
+def compute_flatness_constraints(mol, idx_map):
+ planar_double_bond_smarts = Chem.MolFromSmarts("[C;X3;^2](*)(*)=[C;X3;^2](*)(*)")
+ aromatic_ring_5_smarts = Chem.MolFromSmarts("[ar5^2]1[ar5^2][ar5^2][ar5^2][ar5^2]1")
+ aromatic_ring_6_smarts = Chem.MolFromSmarts(
+ "[ar6^2]1[ar6^2][ar6^2][ar6^2][ar6^2][ar6^2]1"
+ )
+
+ planar_double_bond_constraints = []
+ aromatic_ring_5_constraints = []
+ aromatic_ring_6_constraints = []
+ for match in mol.GetSubstructMatches(planar_double_bond_smarts):
+ if all(i in idx_map for i in match):
+ planar_double_bond_constraints.append(
+ ParsedPlanarBondConstraint(atom_idxs=tuple(idx_map[i] for i in match))
+ )
+ for match in mol.GetSubstructMatches(aromatic_ring_5_smarts):
+ if all(i in idx_map for i in match):
+ aromatic_ring_5_constraints.append(
+ ParsedPlanarRing5Constraint(atom_idxs=tuple(idx_map[i] for i in match))
+ )
+ for match in mol.GetSubstructMatches(aromatic_ring_6_smarts):
+ if all(i in idx_map for i in match):
+ aromatic_ring_6_constraints.append(
+ ParsedPlanarRing6Constraint(atom_idxs=tuple(idx_map[i] for i in match))
+ )
+
+ return (
+ planar_double_bond_constraints,
+ aromatic_ring_5_constraints,
+ aromatic_ring_6_constraints,
+ )
+
+
+####################################################################################################
+# PARSING
+####################################################################################################
+
+
+def parse_ccd_residue( # noqa: PLR0915, C901
+ name: str,
+ ref_mol: Mol,
+ res_idx: int,
+ gemmi_mol: Optional[gemmi.Residue] = None,
+ is_covalent: bool = False,
+) -> Optional[ParsedResidue]:
+ """Parse an MMCIF ligand.
+
+ First tries to get the SMILES string from the RCSB.
+ Then, tries to infer atom ordering using RDKit.
+
+ Parameters
+ ----------
+ name: str
+ The name of the molecule to parse.
+ components : dict
+ The preprocessed PDB components dictionary.
+ res_idx : int
+ The residue index.
+ gemmi_mol : Optional[gemmi.Residue]
+ The PDB molecule, as a gemmi Residue object, if any.
+
+ Returns
+ -------
+ ParsedResidue, optional
+ The output ParsedResidue, if successful.
+
+ """
+ # Check if we have a PDB structure for this residue,
+ # it could be a missing residue from the sequence
+ is_present = gemmi_mol is not None
+
+ # Save original index (required for parsing connections)
+ if is_present:
+ orig_idx = gemmi_mol.seqid
+ orig_idx = str(orig_idx.num) + str(orig_idx.icode).strip()
+ else:
+ orig_idx = None
+
+ # Check if this is a single heavy atom CCD residue
+ if CalcNumHeavyAtoms(ref_mol) == 1:
+ # Remove hydrogens
+ ref_mol = AllChem.RemoveHs(ref_mol, sanitize=False)
+
+ pos = (0, 0, 0)
+ bfactor = 0
+ if is_present:
+ pos = (
+ gemmi_mol[0].pos.x,
+ gemmi_mol[0].pos.y,
+ gemmi_mol[0].pos.z,
+ )
+ bfactor = gemmi_mol[0].b_iso
+ ref_atom = ref_mol.GetAtoms()[0]
+ atom = ParsedAtom(
+ name=ref_atom.GetProp("name"),
+ coords=pos,
+ is_present=is_present,
+ bfactor=bfactor,
+ )
+ unk_prot_id = const.unk_token_ids["PROTEIN"]
+ residue = ParsedResidue(
+ name=name,
+ type=unk_prot_id,
+ atoms=[atom],
+ bonds=[],
+ idx=res_idx,
+ orig_idx=orig_idx,
+ atom_center=0, # Placeholder, no center
+ atom_disto=0, # Placeholder, no center
+ is_standard=False,
+ is_present=is_present,
+ )
+ return residue
+
+ # If multi-atom, start by getting the PDB coordinates
+ pdb_pos = {}
+ bfactor = {}
+ if is_present:
+ # Match atoms based on names
+ for atom in gemmi_mol:
+ atom: gemmi.Atom
+ pos = (atom.pos.x, atom.pos.y, atom.pos.z)
+ pdb_pos[atom.name] = pos
+ bfactor[atom.name] = atom.b_iso
+ # Parse each atom in order of the reference mol
+ atoms = []
+ atom_idx = 0
+ idx_map = {} # Used for bonds later
+
+ for i, atom in enumerate(ref_mol.GetAtoms()):
+ # Ignore Hydrogen atoms
+ if atom.GetAtomicNum() == 1:
+ continue
+
+ # Get atom name, charge, element and reference coordinates
+ atom_name = atom.GetProp("name")
+
+ # If the atom is a leaving atom, skip if not in the PDB and is_covalent
+ if (
+ atom.HasProp("leaving_atom")
+ and int(atom.GetProp("leaving_atom")) == 1
+ and is_covalent
+ and (atom_name not in pdb_pos)
+ ):
+ continue
+
+ # Get PDB coordinates, if any
+ coords = pdb_pos.get(atom_name)
+ if coords is None:
+ atom_is_present = False
+ coords = (0, 0, 0)
+ else:
+ atom_is_present = True
+
+ # Add atom to list
+ atoms.append(
+ ParsedAtom(
+ name=atom_name,
+ coords=coords,
+ is_present=atom_is_present,
+ bfactor=bfactor.get(atom_name, 0),
+ )
+ )
+ idx_map[i] = atom_idx
+ atom_idx += 1
+
+ # Load bonds
+ bonds = []
+ unk_bond = const.bond_type_ids[const.unk_bond_type]
+ for bond in ref_mol.GetBonds():
+ idx_1 = bond.GetBeginAtomIdx()
+ idx_2 = bond.GetEndAtomIdx()
+
+ # Skip bonds with atoms ignored
+ if (idx_1 not in idx_map) or (idx_2 not in idx_map):
+ continue
+
+ idx_1 = idx_map[idx_1]
+ idx_2 = idx_map[idx_2]
+ start = min(idx_1, idx_2)
+ end = max(idx_1, idx_2)
+ bond_type = bond.GetBondType().name
+ bond_type = const.bond_type_ids.get(bond_type, unk_bond)
+ bonds.append(ParsedBond(start, end, bond_type))
+
+ rdkit_bounds_constraints = compute_geometry_constraints(ref_mol, idx_map)
+ chiral_atom_constraints = compute_chiral_atom_constraints(ref_mol, idx_map)
+ stereo_bond_constraints = compute_stereo_bond_constraints(ref_mol, idx_map)
+ planar_bond_constraints, planar_ring_5_constraints, planar_ring_6_constraints = (
+ compute_flatness_constraints(ref_mol, idx_map)
+ )
+
+ unk_prot_id = const.unk_token_ids["PROTEIN"]
+ return ParsedResidue(
+ name=name,
+ type=unk_prot_id,
+ atoms=atoms,
+ bonds=bonds,
+ idx=res_idx,
+ atom_center=0,
+ atom_disto=0,
+ orig_idx=orig_idx,
+ is_standard=False,
+ is_present=is_present,
+ rdkit_bounds_constraints=rdkit_bounds_constraints,
+ chiral_atom_constraints=chiral_atom_constraints,
+ stereo_bond_constraints=stereo_bond_constraints,
+ planar_bond_constraints=planar_bond_constraints,
+ planar_ring_5_constraints=planar_ring_5_constraints,
+ planar_ring_6_constraints=planar_ring_6_constraints,
+ )
+
+
+def parse_polymer( # noqa: C901, PLR0915, PLR0912
+ polymer: gemmi.ResidueSpan,
+ polymer_type: gemmi.PolymerType,
+ sequence: list[str],
+ chain_id: str,
+ entity: str,
+ mols: dict[str, Mol],
+ moldir: str,
+) -> Optional[ParsedChain]:
+ """Process a gemmi Polymer into a chain object.
+
+ Performs alignment of the full sequence to the polymer
+ residues. Loads coordinates and masks for the atoms in
+ the polymer, following the ordering in const.atom_order.
+
+ Parameters
+ ----------
+ polymer : gemmi.ResidueSpan
+ The polymer to process.
+ polymer_type : gemmi.PolymerType
+ The polymer type.
+ sequence : str
+ The full sequence of the polymer.
+ chain_id : str
+ The chain identifier.
+ entity : str
+ The entity name.
+ components : dict[str, Mol]
+ The preprocessed PDB components dictionary.
+
+ Returns
+ -------
+ ParsedChain, optional
+ The output chain, if successful.
+
+ Raises
+ ------
+ ValueError
+ If the alignment fails.
+
+ """
+ # Ignore microheterogeneities (pick first)
+ sequence = [gemmi.Entity.first_mon(item) for item in sequence]
+
+ # Align full sequence to polymer residues
+ # This is a simple way to handle all the different numbering schemes
+ result = gemmi.align_sequence_to_polymer(
+ sequence,
+ polymer,
+ polymer_type,
+ gemmi.AlignmentScoring(),
+ )
+
+ # Get coordinates and masks
+ i = 0
+ ref_res = set(const.tokens)
+ parsed = []
+ for j, match in enumerate(result.match_string):
+ # Get residue name from sequence
+ res_name = sequence[j]
+
+ # Check if we have a match in the structure
+ res = None
+ name_to_atom = {}
+
+ if match == "|":
+ # Get pdb residue
+ res = polymer[i]
+ name_to_atom = {a.name.upper(): a for a in res}
+
+ # Double check the match
+ if res.name != res_name:
+ msg = "Alignment mismatch!"
+ raise ValueError(msg)
+
+ # Increment polymer index
+ i += 1
+
+ # Map MSE to MET, put the selenium atom in the sulphur column
+ if res_name == "MSE":
+ res_name = "MET"
+ if "SE" in name_to_atom:
+ name_to_atom["SD"] = name_to_atom["SE"]
+
+ # Handle non-standard residues
+ elif res_name not in ref_res:
+ modified_mol = get_mol(res_name, mols, moldir)
+ if modified_mol is not None:
+ residue = parse_ccd_residue(
+ name=res_name,
+ ref_mol=modified_mol,
+ res_idx=j,
+ gemmi_mol=res,
+ is_covalent=True,
+ )
+ parsed.append(residue)
+ continue
+ else: # noqa: RET507
+ res_name = "UNK"
+
+ # Load regular residues
+ ref_mol = get_mol(res_name, mols, moldir)
+ ref_mol = AllChem.RemoveHs(ref_mol, sanitize=False)
+
+ # Only use reference atoms set in constants
+ ref_name_to_atom = {a.GetProp("name"): a for a in ref_mol.GetAtoms()}
+ ref_atoms = [ref_name_to_atom[a] for a in const.ref_atoms[res_name]]
+
+ # Iterate, always in the same order
+ atoms: list[ParsedAtom] = []
+
+ for ref_atom in ref_atoms:
+ # Get atom name
+ atom_name = ref_atom.GetProp("name")
+
+ # Get coordinates from PDB
+ if atom_name in name_to_atom:
+ atom: gemmi.Atom = name_to_atom[atom_name]
+ atom_is_present = True
+ coords = (atom.pos.x, atom.pos.y, atom.pos.z)
+ bfactor = atom.b_iso
+ else:
+ atom_is_present = False
+ coords = (0, 0, 0)
+ bfactor = 0
+
+ # Add atom to list
+ atoms.append(
+ ParsedAtom(
+ name=atom_name,
+ coords=coords,
+ is_present=atom_is_present,
+ bfactor=bfactor,
+ )
+ )
+
+ # Fix naming errors in arginine residues where NH2 is
+ # incorrectly assigned to be closer to CD than NH1
+ if (res is not None) and (res_name == "ARG"):
+ ref_atoms: list[str] = const.ref_atoms["ARG"]
+ cd = atoms[ref_atoms.index("CD")]
+ nh1 = atoms[ref_atoms.index("NH1")]
+ nh2 = atoms[ref_atoms.index("NH2")]
+
+ cd_coords = np.array(cd.coords)
+ nh1_coords = np.array(nh1.coords)
+ nh2_coords = np.array(nh2.coords)
+
+ if all(atom.is_present for atom in (cd, nh1, nh2)) and (
+ np.linalg.norm(nh1_coords - cd_coords)
+ > np.linalg.norm(nh2_coords - cd_coords)
+ ):
+ atoms[ref_atoms.index("NH1")] = replace(nh1, coords=nh2.coords)
+ atoms[ref_atoms.index("NH2")] = replace(nh2, coords=nh1.coords)
+
+ # Add residue to parsed list
+ if res is not None:
+ orig_idx = res.seqid
+ orig_idx = str(orig_idx.num) + str(orig_idx.icode).strip()
+ else:
+ orig_idx = None
+
+ atom_center = const.res_to_center_atom_id[res_name]
+ atom_disto = const.res_to_disto_atom_id[res_name]
+ parsed.append(
+ ParsedResidue(
+ name=res_name,
+ type=const.token_ids[res_name],
+ atoms=atoms,
+ bonds=[],
+ idx=j,
+ atom_center=atom_center,
+ atom_disto=atom_disto,
+ is_standard=True,
+ is_present=res is not None,
+ orig_idx=orig_idx,
+ )
+ )
+
+ # Get polymer class
+ if polymer_type == gemmi.PolymerType.PeptideL:
+ chain_type = const.chain_type_ids["PROTEIN"]
+ elif polymer_type == gemmi.PolymerType.Dna:
+ chain_type = const.chain_type_ids["DNA"]
+ elif polymer_type == gemmi.PolymerType.Rna:
+ chain_type = const.chain_type_ids["RNA"]
+
+ # Return polymer object
+ return ParsedChain(
+ name=chain_id,
+ entity=entity,
+ residues=parsed,
+ type=chain_type,
+ sequence=gemmi.one_letter_code(sequence),
+ )
+
+
+def parse_connection(
+ connection: gemmi.Connection,
+ chains: list[ParsedChain],
+ subchain_map: dict[tuple[str, int], str],
+) -> ParsedConnection:
+ """Parse (covalent) connection from a gemmi Connection.
+
+ Parameters
+ ----------
+ connections : gemmi.Connectionlist
+ The connection list to parse.
+ chains : list[Chain]
+ The parsed chains.
+ subchain_map : dict[tuple[str, int], str]
+ The mapping from chain, residue index to subchain name.
+
+ Returns
+ -------
+ list[Connection]
+ The parsed connections.
+
+ """
+ # Map to correct subchains
+ chain_1_name = connection.partner1.chain_name
+ chain_2_name = connection.partner2.chain_name
+
+ res_1_id = connection.partner1.res_id.seqid
+ res_1_id = str(res_1_id.num) + str(res_1_id.icode).strip()
+
+ res_2_id = connection.partner2.res_id.seqid
+ res_2_id = str(res_2_id.num) + str(res_2_id.icode).strip()
+
+ subchain_1 = subchain_map[(chain_1_name, res_1_id)]
+ subchain_2 = subchain_map[(chain_2_name, res_2_id)]
+
+ # Get chain indices
+ chain_1 = next(chain for chain in chains if (chain.name == subchain_1))
+ chain_2 = next(chain for chain in chains if (chain.name == subchain_2))
+
+ # Get residue indices
+ res_1_idx, res_1 = next(
+ (idx, res)
+ for idx, res in enumerate(chain_1.residues)
+ if (res.orig_idx == res_1_id)
+ )
+ res_2_idx, res_2 = next(
+ (idx, res)
+ for idx, res in enumerate(chain_2.residues)
+ if (res.orig_idx == res_2_id)
+ )
+
+ # Get atom indices
+ atom_index_1 = next(
+ idx
+ for idx, atom in enumerate(res_1.atoms)
+ if atom.name == connection.partner1.atom_name
+ )
+ atom_index_2 = next(
+ idx
+ for idx, atom in enumerate(res_2.atoms)
+ if atom.name == connection.partner2.atom_name
+ )
+
+ conn = ParsedConnection(
+ chain_1=subchain_1,
+ chain_2=subchain_2,
+ residue_index_1=res_1_idx,
+ residue_index_2=res_2_idx,
+ atom_index_1=atom_index_1,
+ atom_index_2=atom_index_2,
+ )
+
+ return conn
+
+
+def parse_mmcif( # noqa: C901, PLR0915, PLR0912
+ path: str,
+ mols: Optional[dict[str, Mol]] = None,
+ moldir: Optional[str] = None,
+ use_assembly: bool = True,
+ call_compute_interfaces: bool = True,
+) -> ParsedStructure:
+ """Parse a structure in MMCIF format.
+
+ Parameters
+ ----------
+ mmcif_file : PathLike
+ Path to the MMCIF file.
+ components: Mapping[str, Mol]
+ The preprocessed PDB components dictionary.
+
+ Returns
+ -------
+ ParsedStructure
+ The parsed structure.
+
+ """
+ # Disable rdkit warnings
+ blocker = rdBase.BlockLogs() # noqa: F841
+
+ # set mols
+ mols = {} if mols is None else mols
+
+ # Parse MMCIF input file
+ block = gemmi.cif.read(str(path))[0]
+
+ # Extract medatadata
+ deposit_date, release_date, revision_date = get_dates(block)
+ resolution = get_resolution(block)
+ method = get_method(block)
+ temperature, ph = get_experiment_conditions(block)
+
+ # Load structure object
+ structure = gemmi.make_structure_from_block(block)
+
+ # Clean up the structure
+ structure.merge_chain_parts()
+ structure.remove_waters()
+ structure.remove_hydrogens()
+ structure.remove_alternative_conformations()
+ structure.remove_empty_chains()
+
+ # Expand assembly 1
+ if use_assembly and structure.assemblies:
+ how = gemmi.HowToNameCopiedChain.AddNumber
+ assembly_name = structure.assemblies[0].name
+ structure.transform_to_assembly(assembly_name, how=how)
+
+ # Parse entities
+ # Create mapping from subchain id to entity
+ entities: dict[str, gemmi.Entity] = {}
+ entity_ids: dict[str, int] = {}
+ for entity_id, entity in enumerate(structure.entities):
+ entity: gemmi.Entity
+ if entity.entity_type.name == "Water":
+ continue
+ for subchain_id in entity.subchains:
+ entities[subchain_id] = entity
+ entity_ids[subchain_id] = entity_id
+
+ # Create mapping from chain, residue to subchains
+ # since a Connection uses the chains and not subchins
+ subchain_map = {}
+ for chain in structure[0]:
+ for residue in chain:
+ seq_id = residue.seqid
+ seq_id = str(seq_id.num) + str(seq_id.icode).strip()
+ subchain_map[(chain.name, seq_id)] = residue.subchain
+
+ # Find covalent ligands
+ covalent_chain_ids = compute_covalent_ligands(
+ connections=structure.connections,
+ subchain_map=subchain_map,
+ entities=entities,
+ )
+
+ # Parse chains
+ chains: list[ParsedChain] = []
+ for raw_chain in structure[0].subchains():
+ # Check chain type
+ subchain_id = raw_chain.subchain_id()
+ entity: gemmi.Entity = entities[subchain_id]
+ entity_type = entity.entity_type.name
+
+ # Parse a polymer
+ if entity_type == "Polymer":
+ # Skip PeptideD, DnaRnaHybrid, Pna, Other
+ if entity.polymer_type.name not in {
+ "PeptideL",
+ "Dna",
+ "Rna",
+ }:
+ continue
+
+ # Add polymer if successful
+ parsed_polymer = parse_polymer(
+ polymer=raw_chain,
+ polymer_type=entity.polymer_type,
+ sequence=entity.full_sequence,
+ chain_id=subchain_id,
+ entity=entity.name,
+ mols=mols,
+ moldir=moldir,
+ )
+ if parsed_polymer is not None:
+ chains.append(parsed_polymer)
+
+ # Parse a non-polymer
+ elif entity_type in {"NonPolymer", "Branched"}:
+ # Skip UNL
+ if any(lig.name == "UNL" for lig in raw_chain):
+ continue
+
+ residues = []
+ for lig_idx, ligand in enumerate(raw_chain):
+ # Check if ligand is covalent
+ if entity_type == "Branched":
+ is_covalent = True
+ else:
+ is_covalent = subchain_id in covalent_chain_ids
+
+ ligand: gemmi.Residue
+ ligand_mol = get_mol(ligand.name, mols, moldir)
+
+ residue = parse_ccd_residue(
+ name=ligand.name,
+ ref_mol=ligand_mol,
+ res_idx=lig_idx,
+ gemmi_mol=ligand,
+ is_covalent=is_covalent,
+ )
+ residues.append(residue)
+
+ if residues:
+ chains.append(
+ ParsedChain(
+ name=subchain_id,
+ entity=entity.name,
+ residues=residues,
+ type=const.chain_type_ids["NONPOLYMER"],
+ )
+ )
+
+ # If no chains parsed fail
+ if not chains:
+ msg = "No chains parsed!"
+ raise ValueError(msg)
+
+ # Want to traverse subchains in same order as reference structure
+ ref_chain_map = {ref_chain.name: i for i, ref_chain in enumerate(chains)}
+ all_ensembles = [chains]
+
+ # Loop through different structures in model
+ for struct in list(structure)[1:]:
+ struct: gemmi.Model
+ ensemble_chains = {}
+
+ for raw_chain in struct.subchains():
+ # Check chain type
+ subchain_id = raw_chain.subchain_id()
+ entity: gemmi.Entity = entities[subchain_id]
+ entity_type = entity.entity_type.name
+
+ # Parse a polymer
+ if entity_type == "Polymer":
+ # Skip PeptideD, DnaRnaHybrid, Pna, Other
+ if entity.polymer_type.name not in {
+ "PeptideL",
+ "Dna",
+ "Rna",
+ }:
+ continue
+
+ # Add polymer if successful
+ parsed_polymer = parse_polymer(
+ polymer=raw_chain,
+ polymer_type=entity.polymer_type,
+ sequence=entity.full_sequence,
+ chain_id=subchain_id,
+ entity=entity.name,
+ mols=mols,
+ moldir=moldir,
+ )
+ if parsed_polymer is not None:
+ ensemble_chains[ref_chain_map[subchain_id]] = parsed_polymer
+
+ # Parse a non-polymer
+ elif entity_type in {"NonPolymer", "Branched"}:
+ # Skip UNL
+ if any(lig.name == "UNL" for lig in raw_chain):
+ continue
+
+ residues = []
+ for lig_idx, ligand in enumerate(raw_chain):
+ # Check if ligand is covalent
+ if entity_type == "Branched":
+ is_covalent = True
+ else:
+ is_covalent = subchain_id in covalent_chain_ids
+
+ ligand: gemmi.Residue
+ ligand_mol = get_mol(ligand.name, mols, moldir)
+
+ residue = parse_ccd_residue(
+ name=ligand.name,
+ ref_mol=ligand_mol,
+ res_idx=lig_idx,
+ gemmi_mol=ligand,
+ is_covalent=is_covalent,
+ )
+ residues.append(residue)
+
+ if residues:
+ parsed_non_polymer = ParsedChain(
+ name=subchain_id,
+ entity=entity.name,
+ residues=residues,
+ type=const.chain_type_ids["NONPOLYMER"],
+ )
+ ensemble_chains[ref_chain_map[subchain_id]] = parsed_non_polymer
+
+ # Ensure ensemble chains are in the same order as reference structure
+ ensemble_chains = [ensemble_chains[idx] for idx in range(len(ensemble_chains))]
+ all_ensembles.append(ensemble_chains)
+
+ # Parse covalent connections
+ connections: list[ParsedConnection] = []
+ for connection in structure.connections:
+ # Skip non-covalent connections
+ connection: gemmi.Connection
+ if connection.type.name != "Covale":
+ continue
+ try:
+ parsed_connection = parse_connection(
+ connection=connection,
+ chains=chains,
+ subchain_map=subchain_map,
+ )
+ except Exception: # noqa: S112, BLE001
+ continue
+ connections.append(parsed_connection)
+
+ # Create tables
+ atom_data = []
+ bond_data = []
+ res_data = []
+ chain_data = []
+ ensemble_data = []
+ coords_data = defaultdict(list)
+
+ rdkit_bounds_constraint_data = []
+ chiral_atom_constraint_data = []
+ stereo_bond_constraint_data = []
+ planar_bond_constraint_data = []
+ planar_ring_5_constraint_data = []
+ planar_ring_6_constraint_data = []
+
+ # Convert parsed chains to tables
+ atom_idx = 0
+ res_idx = 0
+ sym_count = {}
+ chain_to_idx = {}
+ res_to_idx = {}
+ chain_to_seq = {}
+
+ for asym_id, chain in enumerate(chains):
+ # Compute number of atoms and residues
+ res_num = len(chain.residues)
+ atom_num = sum(len(res.atoms) for res in chain.residues)
+
+ # Get same chain across models in ensemble
+ ensemble_chains = [ensemble[asym_id] for ensemble in all_ensembles]
+ assert len(ensemble_chains) == len(all_ensembles)
+ for ensemble_chain in ensemble_chains:
+ assert len(ensemble_chain.residues) == res_num
+ assert sum(len(res.atoms) for res in ensemble_chain.residues) == atom_num
+
+ # Find all copies of this chain in the assembly
+ entity_id = entity_ids[chain.name]
+ sym_id = sym_count.get(entity_id, 0)
+ chain_data.append(
+ (
+ chain.name,
+ chain.type,
+ entity_id,
+ sym_id,
+ asym_id,
+ atom_idx,
+ atom_num,
+ res_idx,
+ res_num,
+ 0,
+ )
+ )
+ chain_to_idx[chain.name] = asym_id
+ sym_count[entity_id] = sym_id + 1
+ if chain.sequence is not None:
+ chain_to_seq[chain.name] = chain.sequence
+
+ # Add residue, atom, bond, data
+ for i, res in enumerate(chain.residues):
+ # Get same residue across models in ensemble
+ ensemble_residues = [
+ ensemble_chain.residues[i] for ensemble_chain in ensemble_chains
+ ]
+ assert len(ensemble_residues) == len(all_ensembles)
+ for ensemble_res in ensemble_residues:
+ assert ensemble_res.name == res.name
+
+ atom_center = atom_idx + res.atom_center
+ atom_disto = atom_idx + res.atom_disto
+ res_data.append(
+ (
+ res.name,
+ res.type,
+ res.idx,
+ atom_idx,
+ len(res.atoms),
+ atom_center,
+ atom_disto,
+ res.is_standard,
+ res.is_present,
+ )
+ )
+ res_to_idx[(chain.name, i)] = (res_idx, atom_idx)
+
+ if res.rdkit_bounds_constraints is not None:
+ for constraint in res.rdkit_bounds_constraints:
+ rdkit_bounds_constraint_data.append( # noqa: PERF401
+ (
+ tuple(
+ c_atom_idx + atom_idx
+ for c_atom_idx in constraint.atom_idxs
+ ),
+ constraint.is_bond,
+ constraint.is_angle,
+ constraint.upper_bound,
+ constraint.lower_bound,
+ )
+ )
+ if res.chiral_atom_constraints is not None:
+ for constraint in res.chiral_atom_constraints:
+ chiral_atom_constraint_data.append( # noqa: PERF401
+ (
+ tuple(
+ c_atom_idx + atom_idx
+ for c_atom_idx in constraint.atom_idxs
+ ),
+ constraint.is_reference,
+ constraint.is_r,
+ )
+ )
+ if res.stereo_bond_constraints is not None:
+ for constraint in res.stereo_bond_constraints:
+ stereo_bond_constraint_data.append( # noqa: PERF401
+ (
+ tuple(
+ c_atom_idx + atom_idx
+ for c_atom_idx in constraint.atom_idxs
+ ),
+ constraint.is_check,
+ constraint.is_e,
+ )
+ )
+ if res.planar_bond_constraints is not None:
+ for constraint in res.planar_bond_constraints:
+ planar_bond_constraint_data.append( # noqa: PERF401
+ (
+ tuple(
+ c_atom_idx + atom_idx
+ for c_atom_idx in constraint.atom_idxs
+ ),
+ )
+ )
+ if res.planar_ring_5_constraints is not None:
+ for constraint in res.planar_ring_5_constraints:
+ planar_ring_5_constraint_data.append( # noqa: PERF401
+ (
+ tuple(
+ c_atom_idx + atom_idx
+ for c_atom_idx in constraint.atom_idxs
+ ),
+ )
+ )
+ if res.planar_ring_6_constraints is not None:
+ for constraint in res.planar_ring_6_constraints:
+ planar_ring_6_constraint_data.append( # noqa: PERF401
+ (
+ tuple(
+ c_atom_idx + atom_idx
+ for c_atom_idx in constraint.atom_idxs
+ ),
+ )
+ )
+
+ for bond in res.bonds:
+ chain_1 = asym_id
+ chain_2 = asym_id
+ res_1 = res_idx
+ res_2 = res_idx
+ atom_1 = atom_idx + bond.atom_1
+ atom_2 = atom_idx + bond.atom_2
+ bond_data.append(
+ (
+ chain_1,
+ chain_2,
+ res_1,
+ res_2,
+ atom_1,
+ atom_2,
+ bond.type,
+ )
+ )
+
+ for a_idx, atom in enumerate(res.atoms):
+ # Get same atom across models in ensemble
+ ensemble_atoms = [
+ ensemble_res.atoms[a_idx] for ensemble_res in ensemble_residues
+ ]
+ assert len(ensemble_atoms) == len(all_ensembles)
+ for e_idx, ensemble_atom in enumerate(ensemble_atoms):
+ assert ensemble_atom.name == atom.name
+ assert atom.is_present == ensemble_atom.is_present
+
+ coords_data[e_idx].append(ensemble_atom.coords)
+
+ atom_data.append(
+ (
+ atom.name,
+ atom.coords,
+ atom.is_present,
+ atom.bfactor,
+ 1.0, # plddt is 1 for real data
+ )
+ )
+ atom_idx += 1
+
+ res_idx += 1
+
+ # Create coordinates table
+ coords_data_ = []
+ for e_idx in range(len(coords_data)):
+ ensemble_data.append((e_idx * atom_idx, atom_idx))
+ coords_data_.append(coords_data[e_idx])
+ coords_data = [(x,) for xs in coords_data_ for x in xs]
+
+ # Convert connections to tables
+ for conn in connections:
+ chain_1_idx = chain_to_idx[conn.chain_1]
+ chain_2_idx = chain_to_idx[conn.chain_2]
+ res_1_idx, atom_1_offset = res_to_idx[(conn.chain_1, conn.residue_index_1)]
+ res_2_idx, atom_2_offset = res_to_idx[(conn.chain_2, conn.residue_index_2)]
+ atom_1_idx = atom_1_offset + conn.atom_index_1
+ atom_2_idx = atom_2_offset + conn.atom_index_2
+ bond_data.append(
+ (
+ chain_1_idx,
+ chain_2_idx,
+ res_1_idx,
+ res_2_idx,
+ atom_1_idx,
+ atom_2_idx,
+ const.bond_type_ids["COVALENT"],
+ )
+ )
+
+ # Convert into datatypes
+ atoms = np.array(atom_data, dtype=AtomV2)
+ bonds = np.array(bond_data, dtype=BondV2)
+ residues = np.array(res_data, dtype=Residue)
+ chains = np.array(chain_data, dtype=Chain)
+ mask = np.ones(len(chain_data), dtype=bool)
+ ensemble = np.array(ensemble_data, dtype=Ensemble)
+ coords = np.array(coords_data, dtype=Coords)
+ rdkit_bounds_constraints = np.array(
+ rdkit_bounds_constraint_data, dtype=RDKitBoundsConstraint
+ )
+ chiral_atom_constraints = np.array(
+ chiral_atom_constraint_data, dtype=ChiralAtomConstraint
+ )
+ stereo_bond_constraints = np.array(
+ stereo_bond_constraint_data, dtype=StereoBondConstraint
+ )
+ planar_bond_constraints = np.array(
+ planar_bond_constraint_data, dtype=PlanarBondConstraint
+ )
+ planar_ring_5_constraints = np.array(
+ planar_ring_5_constraint_data, dtype=PlanarRing5Constraint
+ )
+ planar_ring_6_constraints = np.array(
+ planar_ring_6_constraint_data, dtype=PlanarRing6Constraint
+ )
+ residue_constraints = ResidueConstraints(
+ rdkit_bounds_constraints=rdkit_bounds_constraints,
+ chiral_atom_constraints=chiral_atom_constraints,
+ stereo_bond_constraints=stereo_bond_constraints,
+ planar_bond_constraints=planar_bond_constraints,
+ planar_ring_5_constraints=planar_ring_5_constraints,
+ planar_ring_6_constraints=planar_ring_6_constraints,
+ )
+
+ # Compute interface chains (find chains with a heavy atom within 5A)
+ if call_compute_interfaces:
+ interfaces = compute_interfaces(atoms, chains)
+ else:
+ interfaces = np.array([], dtype=Interface)
+
+ # Return parsed structure
+ info = StructureInfo(
+ deposited=deposit_date,
+ revised=revision_date,
+ released=release_date,
+ resolution=resolution,
+ method=method,
+ num_chains=len(chains),
+ num_interfaces=len(interfaces),
+ temperature=temperature,
+ pH=ph,
+ )
+
+ data = StructureV2(
+ atoms=atoms,
+ bonds=bonds,
+ residues=residues,
+ chains=chains,
+ interfaces=interfaces,
+ mask=mask,
+ ensemble=ensemble,
+ coords=coords,
+ )
+
+ return ParsedStructure(
+ data=data,
+ info=info,
+ sequences=chain_to_seq,
+ residue_constraints=residue_constraints,
+ )
diff --git a/forks/boltz/src/boltz/data/parse/schema.py b/forks/boltz/src/boltz/data/parse/schema.py
new file mode 100644
index 00000000..a10260bc
--- /dev/null
+++ b/forks/boltz/src/boltz/data/parse/schema.py
@@ -0,0 +1,1826 @@
+from collections.abc import Mapping
+from dataclasses import dataclass
+from pathlib import Path
+from typing import Optional
+
+import click
+import numpy as np
+from Bio import Align
+from chembl_structure_pipeline.exclude_flag import exclude_flag
+from chembl_structure_pipeline.standardizer import standardize_mol
+from rdkit import Chem, rdBase
+from rdkit.Chem import AllChem, HybridizationType
+from rdkit.Chem.MolStandardize import rdMolStandardize
+from rdkit.Chem.rdchem import BondStereo, Conformer, Mol
+from rdkit.Chem.rdDistGeom import GetMoleculeBoundsMatrix
+from rdkit.Chem.rdMolDescriptors import CalcNumHeavyAtoms
+from scipy.optimize import linear_sum_assignment
+
+from boltz.data import const
+from boltz.data.mol import load_molecules
+from boltz.data.parse.mmcif import parse_mmcif
+from boltz.data.types import (
+ AffinityInfo,
+ Atom,
+ AtomV2,
+ Bond,
+ BondV2,
+ Chain,
+ ChainInfo,
+ ChiralAtomConstraint,
+ Connection,
+ Coords,
+ Ensemble,
+ InferenceOptions,
+ Interface,
+ PlanarBondConstraint,
+ PlanarRing5Constraint,
+ PlanarRing6Constraint,
+ RDKitBoundsConstraint,
+ Record,
+ Residue,
+ ResidueConstraints,
+ StereoBondConstraint,
+ Structure,
+ StructureInfo,
+ StructureV2,
+ Target,
+ TemplateInfo,
+)
+
+####################################################################################################
+# DATACLASSES
+####################################################################################################
+
+
+@dataclass(frozen=True)
+class ParsedAtom:
+ """A parsed atom object."""
+
+ name: str
+ element: int
+ charge: int
+ coords: tuple[float, float, float]
+ conformer: tuple[float, float, float]
+ is_present: bool
+ chirality: int
+
+
+@dataclass(frozen=True)
+class ParsedBond:
+ """A parsed bond object."""
+
+ atom_1: int
+ atom_2: int
+ type: int
+
+
+@dataclass(frozen=True)
+class ParsedRDKitBoundsConstraint:
+ """A parsed RDKit bounds constraint object."""
+
+ atom_idxs: tuple[int, int]
+ is_bond: bool
+ is_angle: bool
+ upper_bound: float
+ lower_bound: float
+
+
+@dataclass(frozen=True)
+class ParsedChiralAtomConstraint:
+ """A parsed chiral atom constraint object."""
+
+ atom_idxs: tuple[int, int, int, int]
+ is_reference: bool
+ is_r: bool
+
+
+@dataclass(frozen=True)
+class ParsedStereoBondConstraint:
+ """A parsed stereo bond constraint object."""
+
+ atom_idxs: tuple[int, int, int, int]
+ is_check: bool
+ is_e: bool
+
+
+@dataclass(frozen=True)
+class ParsedPlanarBondConstraint:
+ """A parsed planar bond constraint object."""
+
+ atom_idxs: tuple[int, int, int, int, int, int]
+
+
+@dataclass(frozen=True)
+class ParsedPlanarRing5Constraint:
+ """A parsed planar bond constraint object."""
+
+ atom_idxs: tuple[int, int, int, int, int]
+
+
+@dataclass(frozen=True)
+class ParsedPlanarRing6Constraint:
+ """A parsed planar bond constraint object."""
+
+ atom_idxs: tuple[int, int, int, int, int, int]
+
+
+@dataclass(frozen=True)
+class ParsedResidue:
+ """A parsed residue object."""
+
+ name: str
+ type: int
+ idx: int
+ atoms: list[ParsedAtom]
+ bonds: list[ParsedBond]
+ orig_idx: Optional[int]
+ atom_center: int
+ atom_disto: int
+ is_standard: bool
+ is_present: bool
+ rdkit_bounds_constraints: Optional[list[ParsedRDKitBoundsConstraint]] = None
+ chiral_atom_constraints: Optional[list[ParsedChiralAtomConstraint]] = None
+ stereo_bond_constraints: Optional[list[ParsedStereoBondConstraint]] = None
+ planar_bond_constraints: Optional[list[ParsedPlanarBondConstraint]] = None
+ planar_ring_5_constraints: Optional[list[ParsedPlanarRing5Constraint]] = None
+ planar_ring_6_constraints: Optional[list[ParsedPlanarRing6Constraint]] = None
+
+
+@dataclass(frozen=True)
+class ParsedChain:
+ """A parsed chain object."""
+
+ entity: str
+ type: int
+ residues: list[ParsedResidue]
+ cyclic_period: int
+ sequence: Optional[str] = None
+ affinity: Optional[bool] = False
+ affinity_mw: Optional[float] = None
+
+
+@dataclass(frozen=True)
+class Alignment:
+ """A parsed alignment object."""
+
+ query_st: int
+ query_en: int
+ template_st: int
+ template_en: int
+
+
+####################################################################################################
+# HELPERS
+####################################################################################################
+
+
+def convert_atom_name(name: str) -> tuple[int, int, int, int]:
+ """Convert an atom name to a standard format.
+
+ Parameters
+ ----------
+ name : str
+ The atom name.
+
+ Returns
+ -------
+ Tuple[int, int, int, int]
+ The converted atom name.
+
+ """
+ name = name.strip()
+ name = [ord(c) - 32 for c in name]
+ name = name + [0] * (4 - len(name))
+ return tuple(name)
+
+
+def compute_3d_conformer(mol: Mol, version: str = "v3") -> bool:
+ """Generate 3D coordinates using EKTDG method.
+
+ Taken from `pdbeccdutils.core.component.Component`.
+
+ Parameters
+ ----------
+ mol: Mol
+ The RDKit molecule to process
+ version: str, optional
+ The ETKDG version, defaults ot v3
+
+ Returns
+ -------
+ bool
+ Whether computation was successful.
+
+ """
+ if version == "v3":
+ options = AllChem.ETKDGv3()
+ elif version == "v2":
+ options = AllChem.ETKDGv2()
+ else:
+ options = AllChem.ETKDGv2()
+
+ options.clearConfs = False
+ conf_id = -1
+
+ try:
+ conf_id = AllChem.EmbedMolecule(mol, options)
+
+ if conf_id == -1:
+ print(
+ f"WARNING: RDKit ETKDGv3 failed to generate a conformer for molecule "
+ f"{Chem.MolToSmiles(AllChem.RemoveHs(mol))}, so the program will start with random coordinates. "
+ f"Note that the performance of the model under this behaviour was not tested."
+ )
+ options.useRandomCoords = True
+ conf_id = AllChem.EmbedMolecule(mol, options)
+
+ AllChem.UFFOptimizeMolecule(mol, confId=conf_id, maxIters=1000)
+
+ except RuntimeError:
+ pass # Force field issue here
+ except ValueError:
+ pass # sanitization issue here
+
+ if conf_id != -1:
+ conformer = mol.GetConformer(conf_id)
+ conformer.SetProp("name", "Computed")
+ conformer.SetProp("coord_generation", f"ETKDG{version}")
+
+ return True
+
+ return False
+
+
+def get_conformer(mol: Mol) -> Conformer:
+ """Retrieve an rdkit object for a deemed conformer.
+
+ Inspired by `pdbeccdutils.core.component.Component`.
+
+ Parameters
+ ----------
+ mol: Mol
+ The molecule to process.
+
+ Returns
+ -------
+ Conformer
+ The desired conformer, if any.
+
+ Raises
+ ------
+ ValueError
+ If there are no conformers of the given tyoe.
+
+ """
+ # Try using the computed conformer
+ for c in mol.GetConformers():
+ try:
+ if c.GetProp("name") == "Computed":
+ return c
+ except KeyError: # noqa: PERF203
+ pass
+
+ # Fallback to the ideal coordinates
+ for c in mol.GetConformers():
+ try:
+ if c.GetProp("name") == "Ideal":
+ return c
+ except KeyError: # noqa: PERF203
+ pass
+
+ # Fallback to boltz2 format
+ conf_ids = [int(conf.GetId()) for conf in mol.GetConformers()]
+ if len(conf_ids) > 0:
+ conf_id = conf_ids[0]
+ conformer = mol.GetConformer(conf_id)
+ return conformer
+
+ msg = "Conformer does not exist."
+ raise ValueError(msg)
+
+
+def compute_geometry_constraints(mol: Mol, idx_map):
+ if mol.GetNumAtoms() <= 1:
+ return []
+
+ # Ensure RingInfo is initialized
+ mol.UpdatePropertyCache(strict=False)
+ Chem.GetSymmSSSR(mol) # Compute ring information
+
+ bounds = GetMoleculeBoundsMatrix(
+ mol,
+ set15bounds=True,
+ scaleVDW=True,
+ doTriangleSmoothing=True,
+ useMacrocycle14config=False,
+ )
+ bonds = set(
+ tuple(sorted(b)) for b in mol.GetSubstructMatches(Chem.MolFromSmarts("*~*"))
+ )
+ angles = set(
+ tuple(sorted([a[0], a[2]]))
+ for a in mol.GetSubstructMatches(Chem.MolFromSmarts("*~*~*"))
+ )
+
+ constraints = []
+ for i, j in zip(*np.triu_indices(mol.GetNumAtoms(), k=1)):
+ if i in idx_map and j in idx_map:
+ constraint = ParsedRDKitBoundsConstraint(
+ atom_idxs=(idx_map[i], idx_map[j]),
+ is_bond=tuple(sorted([i, j])) in bonds,
+ is_angle=tuple(sorted([i, j])) in angles,
+ upper_bound=bounds[i, j],
+ lower_bound=bounds[j, i],
+ )
+ constraints.append(constraint)
+ return constraints
+
+
+def compute_chiral_atom_constraints(mol, idx_map):
+ constraints = []
+ if all([atom.HasProp("_CIPRank") for atom in mol.GetAtoms()]):
+ for center_idx, orientation in Chem.FindMolChiralCenters(
+ mol, includeUnassigned=False
+ ):
+ center = mol.GetAtomWithIdx(center_idx)
+ neighbors = [
+ (neighbor.GetIdx(), int(neighbor.GetProp("_CIPRank")))
+ for neighbor in center.GetNeighbors()
+ ]
+ neighbors = sorted(
+ neighbors, key=lambda neighbor: neighbor[1], reverse=True
+ )
+ neighbors = tuple(neighbor[0] for neighbor in neighbors)
+ is_r = orientation == "R"
+
+ if len(neighbors) > 4 or center.GetHybridization() != HybridizationType.SP3:
+ continue
+
+ atom_idxs = (*neighbors[:3], center_idx)
+ if all(i in idx_map for i in atom_idxs):
+ constraints.append(
+ ParsedChiralAtomConstraint(
+ atom_idxs=tuple(idx_map[i] for i in atom_idxs),
+ is_reference=True,
+ is_r=is_r,
+ )
+ )
+
+ if len(neighbors) == 4:
+ for skip_idx in range(3):
+ chiral_set = neighbors[:skip_idx] + neighbors[skip_idx + 1 :]
+ if skip_idx % 2 == 0:
+ atom_idxs = chiral_set[::-1] + (center_idx,)
+ else:
+ atom_idxs = chiral_set + (center_idx,)
+ if all(i in idx_map for i in atom_idxs):
+ constraints.append(
+ ParsedChiralAtomConstraint(
+ atom_idxs=tuple(idx_map[i] for i in atom_idxs),
+ is_reference=False,
+ is_r=is_r,
+ )
+ )
+ return constraints
+
+
+def compute_stereo_bond_constraints(mol, idx_map):
+ constraints = []
+ if all([atom.HasProp("_CIPRank") for atom in mol.GetAtoms()]):
+ for bond in mol.GetBonds():
+ stereo = bond.GetStereo()
+ if stereo in {BondStereo.STEREOE, BondStereo.STEREOZ}:
+ start_atom_idx, end_atom_idx = (
+ bond.GetBeginAtomIdx(),
+ bond.GetEndAtomIdx(),
+ )
+ start_neighbors = [
+ (neighbor.GetIdx(), int(neighbor.GetProp("_CIPRank")))
+ for neighbor in mol.GetAtomWithIdx(start_atom_idx).GetNeighbors()
+ if neighbor.GetIdx() != end_atom_idx
+ ]
+ start_neighbors = sorted(
+ start_neighbors, key=lambda neighbor: neighbor[1], reverse=True
+ )
+ start_neighbors = [neighbor[0] for neighbor in start_neighbors]
+ end_neighbors = [
+ (neighbor.GetIdx(), int(neighbor.GetProp("_CIPRank")))
+ for neighbor in mol.GetAtomWithIdx(end_atom_idx).GetNeighbors()
+ if neighbor.GetIdx() != start_atom_idx
+ ]
+ end_neighbors = sorted(
+ end_neighbors, key=lambda neighbor: neighbor[1], reverse=True
+ )
+ end_neighbors = [neighbor[0] for neighbor in end_neighbors]
+ is_e = stereo == BondStereo.STEREOE
+
+ atom_idxs = (
+ start_neighbors[0],
+ start_atom_idx,
+ end_atom_idx,
+ end_neighbors[0],
+ )
+ if all(i in idx_map for i in atom_idxs):
+ constraints.append(
+ ParsedStereoBondConstraint(
+ atom_idxs=tuple(idx_map[i] for i in atom_idxs),
+ is_check=True,
+ is_e=is_e,
+ )
+ )
+
+ if len(start_neighbors) == 2 and len(end_neighbors) == 2:
+ atom_idxs = (
+ start_neighbors[1],
+ start_atom_idx,
+ end_atom_idx,
+ end_neighbors[1],
+ )
+ if all(i in idx_map for i in atom_idxs):
+ constraints.append(
+ ParsedStereoBondConstraint(
+ atom_idxs=tuple(idx_map[i] for i in atom_idxs),
+ is_check=False,
+ is_e=is_e,
+ )
+ )
+ return constraints
+
+
+def compute_flatness_constraints(mol, idx_map):
+ planar_double_bond_smarts = Chem.MolFromSmarts("[C;X3;^2](*)(*)=[C;X3;^2](*)(*)")
+ aromatic_ring_5_smarts = Chem.MolFromSmarts("[ar5^2]1[ar5^2][ar5^2][ar5^2][ar5^2]1")
+ aromatic_ring_6_smarts = Chem.MolFromSmarts(
+ "[ar6^2]1[ar6^2][ar6^2][ar6^2][ar6^2][ar6^2]1"
+ )
+
+ planar_double_bond_constraints = []
+ aromatic_ring_5_constraints = []
+ aromatic_ring_6_constraints = []
+ for match in mol.GetSubstructMatches(planar_double_bond_smarts):
+ if all(i in idx_map for i in match):
+ planar_double_bond_constraints.append(
+ ParsedPlanarBondConstraint(atom_idxs=tuple(idx_map[i] for i in match))
+ )
+ for match in mol.GetSubstructMatches(aromatic_ring_5_smarts):
+ if all(i in idx_map for i in match):
+ aromatic_ring_5_constraints.append(
+ ParsedPlanarRing5Constraint(atom_idxs=tuple(idx_map[i] for i in match))
+ )
+ for match in mol.GetSubstructMatches(aromatic_ring_6_smarts):
+ if all(i in idx_map for i in match):
+ aromatic_ring_6_constraints.append(
+ ParsedPlanarRing6Constraint(atom_idxs=tuple(idx_map[i] for i in match))
+ )
+
+ return (
+ planar_double_bond_constraints,
+ aromatic_ring_5_constraints,
+ aromatic_ring_6_constraints,
+ )
+
+
+def get_global_alignment_score(query: str, template: str) -> float:
+ """Align a sequence to a template.
+
+ Parameters
+ ----------
+ query : str
+ The query sequence.
+ template : str
+ The template sequence.
+
+ Returns
+ -------
+ float
+ The global alignment score.
+
+ """
+ aligner = Align.PairwiseAligner(scoring="blastp")
+ aligner.mode = "global"
+ score = aligner.align(query, template)[0].score
+ return score
+
+
+def get_local_alignments(query: str, template: str) -> list[Alignment]:
+ """Align a sequence to a template.
+
+ Parameters
+ ----------
+ query : str
+ The query sequence.
+ template : str
+ The template sequence.
+
+ Returns
+ -------
+ Alignment
+ The alignment between the query and template.
+
+ """
+ aligner = Align.PairwiseAligner(scoring="blastp")
+ aligner.mode = "local"
+ aligner.open_gap_score = -1000
+ aligner.extend_gap_score = -1000
+
+ alignments = []
+ for result in aligner.align(query, template):
+ coordinates = result.coordinates
+ alignment = Alignment(
+ query_st=int(coordinates[0][0]),
+ query_en=int(coordinates[0][1]),
+ template_st=int(coordinates[1][0]),
+ template_en=int(coordinates[1][1]),
+ )
+ alignments.append(alignment)
+
+ return alignments
+
+
+def get_template_records_from_search(
+ template_id: str,
+ chain_ids: list[str],
+ sequences: dict[str, str],
+ template_chain_ids: list[str],
+ template_sequences: dict[str, str],
+ force: bool = False,
+ threshold: Optional[float] = None,
+) -> list[TemplateInfo]:
+ """Get template records from an alignment."""
+ # Compute pairwise scores
+ score_matrix = []
+ for chain_id in chain_ids:
+ row = []
+ for template_chain_id in template_chain_ids:
+ chain_seq = sequences[chain_id]
+ template_seq = template_sequences[template_chain_id]
+ score = get_global_alignment_score(chain_seq, template_seq)
+ row.append(score)
+ score_matrix.append(row)
+
+ # Find optimal mapping
+ row_ind, col_ind = linear_sum_assignment(score_matrix, maximize=True)
+
+ # Get alignment records
+ template_records = []
+
+ for row_idx, col_idx in zip(row_ind, col_ind):
+ chain_id = chain_ids[row_idx]
+ template_chain_id = template_chain_ids[col_idx]
+ chain_seq = sequences[chain_id]
+ template_seq = template_sequences[template_chain_id]
+ alignments = get_local_alignments(chain_seq, template_seq)
+
+ for alignment in alignments:
+ template_record = TemplateInfo(
+ name=template_id,
+ query_chain=chain_id,
+ query_st=alignment.query_st,
+ query_en=alignment.query_en,
+ template_chain=template_chain_id,
+ template_st=alignment.template_st,
+ template_en=alignment.template_en,
+ force=force,
+ threshold=threshold,
+ )
+ template_records.append(template_record)
+
+ return template_records
+
+
+def get_template_records_from_matching(
+ template_id: str,
+ chain_ids: list[str],
+ sequences: dict[str, str],
+ template_chain_ids: list[str],
+ template_sequences: dict[str, str],
+ force: bool = False,
+ threshold: Optional[float] = None,
+) -> list[TemplateInfo]:
+ """Get template records from a given matching."""
+ template_records = []
+
+ for chain_id, template_chain_id in zip(chain_ids, template_chain_ids):
+ # Align the sequences
+ chain_seq = sequences[chain_id]
+ template_seq = template_sequences[template_chain_id]
+ alignments = get_local_alignments(chain_seq, template_seq)
+ for alignment in alignments:
+ template_record = TemplateInfo(
+ name=template_id,
+ query_chain=chain_id,
+ query_st=alignment.query_st,
+ query_en=alignment.query_en,
+ template_chain=template_chain_id,
+ template_st=alignment.template_st,
+ template_en=alignment.template_en,
+ force=force,
+ threshold=threshold,
+ )
+ template_records.append(template_record)
+
+ return template_records
+
+
+def get_mol(ccd: str, mols: dict, moldir: str) -> Mol:
+ """Get mol from CCD code.
+
+ Return mol with ccd from mols if it is in mols. Otherwise load it from moldir,
+ add it to mols, and return the mol.
+ """
+ mol = mols.get(ccd)
+ if mol is None:
+ mol = load_molecules(moldir, [ccd])[ccd]
+ return mol
+
+
+####################################################################################################
+# PARSING
+####################################################################################################
+
+
+def parse_ccd_residue(
+ name: str, ref_mol: Mol, res_idx: int, drop_leaving_atoms: bool = False
+) -> Optional[ParsedResidue]:
+ """Parse an MMCIF ligand.
+
+ First tries to get the SMILES string from the RCSB.
+ Then, tries to infer atom ordering using RDKit.
+
+ Parameters
+ ----------
+ name: str
+ The name of the molecule to parse.
+ ref_mol: Mol
+ The reference molecule to parse.
+ res_idx : int
+ The residue index.
+
+ Returns
+ -------
+ ParsedResidue, optional
+ The output ParsedResidue, if successful.
+
+ """
+ unk_chirality = const.chirality_type_ids[const.unk_chirality_type]
+
+ # Check if this is a single heavy atom CCD residue
+ if CalcNumHeavyAtoms(ref_mol) == 1:
+ # Remove hydrogens
+ ref_mol = AllChem.RemoveHs(ref_mol, sanitize=False)
+
+ pos = (0, 0, 0)
+ ref_atom = ref_mol.GetAtoms()[0]
+ chirality_type = const.chirality_type_ids.get(
+ str(ref_atom.GetChiralTag()), unk_chirality
+ )
+ atom = ParsedAtom(
+ name=ref_atom.GetProp("name"),
+ element=ref_atom.GetAtomicNum(),
+ charge=ref_atom.GetFormalCharge(),
+ coords=pos,
+ conformer=(0, 0, 0),
+ is_present=True,
+ chirality=chirality_type,
+ )
+ unk_prot_id = const.unk_token_ids["PROTEIN"]
+ residue = ParsedResidue(
+ name=name,
+ type=unk_prot_id,
+ atoms=[atom],
+ bonds=[],
+ idx=res_idx,
+ orig_idx=None,
+ atom_center=0, # Placeholder, no center
+ atom_disto=0, # Placeholder, no center
+ is_standard=False,
+ is_present=True,
+ )
+ return residue
+
+ # Get reference conformer coordinates
+ conformer = get_conformer(ref_mol)
+
+ # Parse each atom in order of the reference mol
+ atoms = []
+ atom_idx = 0
+ idx_map = {} # Used for bonds later
+
+ for i, atom in enumerate(ref_mol.GetAtoms()):
+ # Ignore Hydrogen atoms
+ if atom.GetAtomicNum() == 1:
+ continue
+
+ # Get atom name, charge, element and reference coordinates
+ atom_name = atom.GetProp("name")
+
+ # Drop leaving atoms for non-canonical amino acids.
+ if drop_leaving_atoms and int(atom.GetProp("leaving_atom")):
+ continue
+
+ charge = atom.GetFormalCharge()
+ element = atom.GetAtomicNum()
+ ref_coords = conformer.GetAtomPosition(atom.GetIdx())
+ ref_coords = (ref_coords.x, ref_coords.y, ref_coords.z)
+ chirality_type = const.chirality_type_ids.get(
+ str(atom.GetChiralTag()), unk_chirality
+ )
+
+ # Get PDB coordinates, if any
+ coords = (0, 0, 0)
+ atom_is_present = True
+
+ # Add atom to list
+ atoms.append(
+ ParsedAtom(
+ name=atom_name,
+ element=element,
+ charge=charge,
+ coords=coords,
+ conformer=ref_coords,
+ is_present=atom_is_present,
+ chirality=chirality_type,
+ )
+ )
+ idx_map[i] = atom_idx
+ atom_idx += 1
+
+ # Load bonds
+ bonds = []
+ unk_bond = const.bond_type_ids[const.unk_bond_type]
+ for bond in ref_mol.GetBonds():
+ idx_1 = bond.GetBeginAtomIdx()
+ idx_2 = bond.GetEndAtomIdx()
+
+ # Skip bonds with atoms ignored
+ if (idx_1 not in idx_map) or (idx_2 not in idx_map):
+ continue
+
+ idx_1 = idx_map[idx_1]
+ idx_2 = idx_map[idx_2]
+ start = min(idx_1, idx_2)
+ end = max(idx_1, idx_2)
+ bond_type = bond.GetBondType().name
+ bond_type = const.bond_type_ids.get(bond_type, unk_bond)
+ bonds.append(ParsedBond(start, end, bond_type))
+
+ rdkit_bounds_constraints = compute_geometry_constraints(ref_mol, idx_map)
+ chiral_atom_constraints = compute_chiral_atom_constraints(ref_mol, idx_map)
+ stereo_bond_constraints = compute_stereo_bond_constraints(ref_mol, idx_map)
+ planar_bond_constraints, planar_ring_5_constraints, planar_ring_6_constraints = (
+ compute_flatness_constraints(ref_mol, idx_map)
+ )
+
+ unk_prot_id = const.unk_token_ids["PROTEIN"]
+ return ParsedResidue(
+ name=name,
+ type=unk_prot_id,
+ atoms=atoms,
+ bonds=bonds,
+ idx=res_idx,
+ atom_center=0,
+ atom_disto=0,
+ orig_idx=None,
+ is_standard=False,
+ is_present=True,
+ rdkit_bounds_constraints=rdkit_bounds_constraints,
+ chiral_atom_constraints=chiral_atom_constraints,
+ stereo_bond_constraints=stereo_bond_constraints,
+ planar_bond_constraints=planar_bond_constraints,
+ planar_ring_5_constraints=planar_ring_5_constraints,
+ planar_ring_6_constraints=planar_ring_6_constraints,
+ )
+
+
+def parse_polymer(
+ sequence: list[str],
+ raw_sequence: str,
+ entity: str,
+ chain_type: str,
+ components: dict[str, Mol],
+ cyclic: bool,
+ mol_dir: Path,
+) -> Optional[ParsedChain]:
+ """Process a sequence into a chain object.
+
+ Performs alignment of the full sequence to the polymer
+ residues. Loads coordinates and masks for the atoms in
+ the polymer, following the ordering in const.atom_order.
+
+ Parameters
+ ----------
+ sequence : list[str]
+ The full sequence of the polymer.
+ entity : str
+ The entity id.
+ entity_type : str
+ The entity type.
+ components : dict[str, Mol]
+ The preprocessed PDB components dictionary.
+
+ Returns
+ -------
+ ParsedChain, optional
+ The output chain, if successful.
+
+ Raises
+ ------
+ ValueError
+ If the alignment fails.
+
+ """
+ ref_res = set(const.tokens)
+ unk_chirality = const.chirality_type_ids[const.unk_chirality_type]
+
+ # Get coordinates and masks
+ parsed = []
+ for res_idx, res_name in enumerate(sequence):
+ # Check if modified residue
+ # Map MSE to MET
+ res_corrected = res_name if res_name != "MSE" else "MET"
+
+ # Handle non-standard residues
+ if res_corrected not in ref_res:
+ ref_mol = get_mol(res_corrected, components, mol_dir)
+ residue = parse_ccd_residue(
+ name=res_corrected,
+ ref_mol=ref_mol,
+ res_idx=res_idx,
+ drop_leaving_atoms=True,
+ )
+ parsed.append(residue)
+ continue
+
+ # Load ref residue
+ ref_mol = get_mol(res_corrected, components, mol_dir)
+ ref_mol = AllChem.RemoveHs(ref_mol, sanitize=False)
+ ref_conformer = get_conformer(ref_mol)
+
+ # Only use reference atoms set in constants
+ ref_name_to_atom = {a.GetProp("name"): a for a in ref_mol.GetAtoms()}
+ ref_atoms = [ref_name_to_atom[a] for a in const.ref_atoms[res_corrected]]
+
+ # Iterate, always in the same order
+ atoms: list[ParsedAtom] = []
+
+ for ref_atom in ref_atoms:
+ # Get atom name
+ atom_name = ref_atom.GetProp("name")
+ idx = ref_atom.GetIdx()
+
+ # Get conformer coordinates
+ ref_coords = ref_conformer.GetAtomPosition(idx)
+ ref_coords = (ref_coords.x, ref_coords.y, ref_coords.z)
+
+ # Set 0 coordinate
+ atom_is_present = True
+ coords = (0, 0, 0)
+
+ # Add atom to list
+ atoms.append(
+ ParsedAtom(
+ name=atom_name,
+ element=ref_atom.GetAtomicNum(),
+ charge=ref_atom.GetFormalCharge(),
+ coords=coords,
+ conformer=ref_coords,
+ is_present=atom_is_present,
+ chirality=const.chirality_type_ids.get(
+ str(ref_atom.GetChiralTag()), unk_chirality
+ ),
+ )
+ )
+
+ atom_center = const.res_to_center_atom_id[res_corrected]
+ atom_disto = const.res_to_disto_atom_id[res_corrected]
+ parsed.append(
+ ParsedResidue(
+ name=res_corrected,
+ type=const.token_ids[res_corrected],
+ atoms=atoms,
+ bonds=[],
+ idx=res_idx,
+ atom_center=atom_center,
+ atom_disto=atom_disto,
+ is_standard=True,
+ is_present=True,
+ orig_idx=None,
+ )
+ )
+
+ if cyclic:
+ cyclic_period = len(sequence)
+ else:
+ cyclic_period = 0
+
+ # Return polymer object
+ return ParsedChain(
+ entity=entity,
+ residues=parsed,
+ type=chain_type,
+ cyclic_period=cyclic_period,
+ sequence=raw_sequence,
+ )
+
+
+def token_spec_to_ids(
+ chain_name, residue_index_or_atom_name, chain_to_idx, atom_idx_map, chains
+):
+ if chains[chain_name].type == const.chain_type_ids["NONPOLYMER"]:
+ # Non-polymer chains are indexed by atom name
+ _, _, atom_idx = atom_idx_map[(chain_name, 0, residue_index_or_atom_name)]
+ return (chain_to_idx[chain_name], atom_idx)
+ else:
+ # Polymer chains are indexed by residue index
+ return chain_to_idx[chain_name], residue_index_or_atom_name - 1
+
+
+def parse_boltz_schema( # noqa: C901, PLR0915, PLR0912
+ name: str,
+ schema: dict,
+ ccd: Mapping[str, Mol],
+ mol_dir: Optional[Path] = None,
+ boltz_2: bool = False,
+) -> Target:
+ """Parse a Boltz input yaml / json.
+
+ The input file should be a dictionary with the following format:
+
+ version: 1
+ sequences:
+ - protein:
+ id: A
+ sequence: "MADQLTEEQIAEFKEAFSLF"
+ msa: path/to/msa1.a3m
+ - protein:
+ id: [B, C]
+ sequence: "AKLSILPWGHC"
+ msa: path/to/msa2.a3m
+ - rna:
+ id: D
+ sequence: "GCAUAGC"
+ - ligand:
+ id: E
+ smiles: "CC1=CC=CC=C1"
+ constraints:
+ - bond:
+ atom1: [A, 1, CA]
+ atom2: [A, 2, N]
+ - pocket:
+ binder: E
+ contacts: [[B, 1], [B, 2]]
+ max_distance: 6
+ - contact:
+ token1: [A, 1]
+ token2: [B, 1]
+ max_distance: 6
+ templates:
+ - cif: path/to/template.cif
+ properties:
+ - affinity:
+ binder: E
+
+ Parameters
+ ----------
+ name : str
+ A name for the input.
+ schema : dict
+ The input schema.
+ components : dict
+ Dictionary of CCD components.
+ mol_dir: Path
+ Path to the directory containing the molecules.
+ boltz2: bool
+ Whether to parse the input for Boltz2.
+
+ Returns
+ -------
+ Target
+ The parsed target.
+
+ """
+ # Assert version 1
+ version = schema.get("version", 1)
+ if version != 1:
+ msg = f"Invalid version {version} in input!"
+ raise ValueError(msg)
+
+ # Disable rdkit warnings
+ blocker = rdBase.BlockLogs() # noqa: F841
+
+ # First group items that have the same type, sequence and modifications
+ items_to_group = {}
+ chain_name_to_entity_type = {}
+
+ for item in schema["sequences"]:
+ # Get entity type
+ entity_type = next(iter(item.keys())).lower()
+ if entity_type not in {"protein", "dna", "rna", "ligand"}:
+ msg = f"Invalid entity type: {entity_type}"
+ raise ValueError(msg)
+
+ # Get sequence
+ if entity_type in {"protein", "dna", "rna"}:
+ seq = str(item[entity_type]["sequence"])
+ elif entity_type == "ligand":
+ assert "smiles" in item[entity_type] or "ccd" in item[entity_type]
+ assert "smiles" not in item[entity_type] or "ccd" not in item[entity_type]
+ if "smiles" in item[entity_type]:
+ seq = str(item[entity_type]["smiles"])
+ else:
+ seq = str(item[entity_type]["ccd"])
+
+ # Group items by entity
+ items_to_group.setdefault((entity_type, seq), []).append(item)
+
+ # Map chain names to entity types
+ chain_names = item[entity_type]["id"]
+ chain_names = [chain_names] if isinstance(chain_names, str) else chain_names
+ for chain_name in chain_names:
+ chain_name_to_entity_type[chain_name] = entity_type
+
+ # Check if any affinity ligand is present
+ affinity_ligands = set()
+ properties = schema.get("properties", [])
+ if properties and not boltz_2:
+ msg = "Affinity prediction is only supported for Boltz2!"
+ raise ValueError(msg)
+
+ for prop in properties:
+ prop_type = next(iter(prop.keys())).lower()
+ if prop_type == "affinity":
+ binder = prop["affinity"]["binder"]
+ if not isinstance(binder, str):
+ # TODO: support multi residue ligands and ccd's
+ msg = "Binder must be a single chain."
+ raise ValueError(msg)
+
+ if binder not in chain_name_to_entity_type:
+ msg = f"Could not find binder with name {binder} in the input!"
+ raise ValueError(msg)
+
+ if chain_name_to_entity_type[binder] != "ligand":
+ msg = (
+ f"Chain {binder} is not a ligand! "
+ "Affinity is currently only supported for ligands."
+ )
+ raise ValueError(msg)
+
+ affinity_ligands.add(binder)
+
+ # Check only one affinity ligand is present
+ if len(affinity_ligands) > 1:
+ msg = "Only one affinity ligand is currently supported!"
+ raise ValueError(msg)
+
+ # Go through entities and parse them
+ extra_mols: dict[str, Mol] = {}
+ chains: dict[str, ParsedChain] = {}
+ chain_to_msa: dict[str, str] = {}
+ entity_to_seq: dict[str, str] = {}
+ is_msa_custom = False
+ is_msa_auto = False
+ ligand_id = 1
+ for entity_id, items in enumerate(items_to_group.values()):
+ # Get entity type and sequence
+ entity_type = next(iter(items[0].keys())).lower()
+
+ # Get ids
+ ids = []
+ for item in items:
+ if isinstance(item[entity_type]["id"], str):
+ ids.append(item[entity_type]["id"])
+ elif isinstance(item[entity_type]["id"], list):
+ ids.extend(item[entity_type]["id"])
+
+ # Check if any affinity ligand is present
+ if len(ids) == 1:
+ affinity = ids[0] in affinity_ligands
+ elif (len(ids) > 1) and any(x in affinity_ligands for x in ids):
+ msg = "Cannot compute affinity for a ligand that has multiple copies!"
+ raise ValueError(msg)
+ else:
+ affinity = False
+
+ # Ensure all the items share the same msa
+ msa = -1
+ if entity_type == "protein":
+ # Get the msa, default to 0, meaning auto-generated
+ msa = items[0][entity_type].get("msa", 0)
+ if (msa is None) or (msa == ""):
+ msa = 0
+
+ # Check if all MSAs are the same within the same entity
+ for item in items:
+ item_msa = item[entity_type].get("msa", 0)
+ if (item_msa is None) or (item_msa == ""):
+ item_msa = 0
+
+ if item_msa != msa:
+ msg = "All proteins with the same sequence must share the same MSA!"
+ raise ValueError(msg)
+
+ # Set the MSA, warn if passed in single-sequence mode
+ if msa == "empty":
+ msa = -1
+ msg = (
+ "Found explicit empty MSA for some proteins, will run "
+ "these in single sequence mode. Keep in mind that the "
+ "model predictions will be suboptimal without an MSA."
+ )
+ click.echo(msg)
+
+ if msa not in (0, -1):
+ is_msa_custom = True
+ elif msa == 0:
+ is_msa_auto = True
+
+ # Parse a polymer
+ if entity_type in {"protein", "dna", "rna"}:
+ # Get token map
+ if entity_type == "rna":
+ token_map = const.rna_letter_to_token
+ elif entity_type == "dna":
+ token_map = const.dna_letter_to_token
+ elif entity_type == "protein":
+ token_map = const.prot_letter_to_token
+ else:
+ msg = f"Unknown polymer type: {entity_type}"
+ raise ValueError(msg)
+
+ # Get polymer info
+ chain_type = const.chain_type_ids[entity_type.upper()]
+ unk_token = const.unk_token[entity_type.upper()]
+
+ # Extract sequence
+ raw_seq = items[0][entity_type]["sequence"]
+ entity_to_seq[entity_id] = raw_seq
+
+ # Convert sequence to tokens
+ seq = [token_map.get(c, unk_token) for c in list(raw_seq)]
+
+ # Apply modifications
+ for mod in items[0][entity_type].get("modifications", []):
+ code = mod["ccd"]
+ idx = mod["position"] - 1 # 1-indexed
+ seq[idx] = code
+
+ cyclic = items[0][entity_type].get("cyclic", False)
+
+ # Parse a polymer
+ parsed_chain = parse_polymer(
+ sequence=seq,
+ raw_sequence=raw_seq,
+ entity=entity_id,
+ chain_type=chain_type,
+ components=ccd,
+ cyclic=cyclic,
+ mol_dir=mol_dir,
+ )
+
+ # Parse a non-polymer
+ elif (entity_type == "ligand") and "ccd" in (items[0][entity_type]):
+ seq = items[0][entity_type]["ccd"]
+
+ if isinstance(seq, str):
+ seq = [seq]
+
+ if affinity and len(seq) > 1:
+ msg = "Cannot compute affinity for multi residue ligands!"
+ raise ValueError(msg)
+
+ residues = []
+ affinity_mw = None
+ for res_idx, code in enumerate(seq):
+ # Get mol
+ ref_mol = get_mol(code, ccd, mol_dir)
+
+ if affinity:
+ affinity_mw = AllChem.Descriptors.MolWt(ref_mol)
+
+ # Parse residue
+ residue = parse_ccd_residue(
+ name=code,
+ ref_mol=ref_mol,
+ res_idx=res_idx,
+ )
+ residues.append(residue)
+
+ # Create multi ligand chain
+ parsed_chain = ParsedChain(
+ entity=entity_id,
+ residues=residues,
+ type=const.chain_type_ids["NONPOLYMER"],
+ cyclic_period=0,
+ sequence=None,
+ affinity=affinity,
+ affinity_mw=affinity_mw,
+ )
+
+ assert not items[0][entity_type].get("cyclic", False), (
+ "Cyclic flag is not supported for ligands"
+ )
+
+ elif (entity_type == "ligand") and ("smiles" in items[0][entity_type]):
+ seq = items[0][entity_type]["smiles"]
+
+ if affinity:
+ seq = standardize(seq)
+
+ mol = AllChem.MolFromSmiles(seq)
+ mol = AllChem.AddHs(mol)
+
+ # Set atom names
+ canonical_order = AllChem.CanonicalRankAtoms(mol)
+ for atom, can_idx in zip(mol.GetAtoms(), canonical_order):
+ atom_name = atom.GetSymbol().upper() + str(can_idx + 1)
+ if len(atom_name) > 4:
+ msg = (
+ f"{seq} has an atom with a name longer than "
+ f"4 characters: {atom_name}."
+ )
+ raise ValueError(msg)
+ atom.SetProp("name", atom_name)
+
+ success = compute_3d_conformer(mol)
+ if not success:
+ msg = f"Failed to compute 3D conformer for {seq}"
+ raise ValueError(msg)
+
+ mol_no_h = AllChem.RemoveHs(mol, sanitize=False)
+ affinity_mw = AllChem.Descriptors.MolWt(mol_no_h) if affinity else None
+ extra_mols[f"LIG{ligand_id}"] = mol_no_h
+ residue = parse_ccd_residue(
+ name=f"LIG{ligand_id}",
+ ref_mol=mol,
+ res_idx=0,
+ )
+
+ ligand_id += 1
+ parsed_chain = ParsedChain(
+ entity=entity_id,
+ residues=[residue],
+ type=const.chain_type_ids["NONPOLYMER"],
+ cyclic_period=0,
+ sequence=None,
+ affinity=affinity,
+ affinity_mw=affinity_mw,
+ )
+
+ assert not items[0][entity_type].get("cyclic", False), (
+ "Cyclic flag is not supported for ligands"
+ )
+
+ else:
+ msg = f"Invalid entity type: {entity_type}"
+ raise ValueError(msg)
+
+ # Add as many chains as provided ids
+ for item in items:
+ ids = item[entity_type]["id"]
+ if isinstance(ids, str):
+ ids = [ids]
+ for chain_name in ids:
+ chains[chain_name] = parsed_chain
+ chain_to_msa[chain_name] = msa
+
+ # Check if msa is custom or auto
+ if is_msa_custom and is_msa_auto:
+ msg = "Cannot mix custom and auto-generated MSAs in the same input!"
+ raise ValueError(msg)
+
+ # If no chains parsed fail
+ if not chains:
+ msg = "No chains parsed!"
+ raise ValueError(msg)
+
+ # Create tables
+ atom_data = []
+ bond_data = []
+ res_data = []
+ chain_data = []
+ protein_chains = set()
+ affinity_info = None
+
+ rdkit_bounds_constraint_data = []
+ chiral_atom_constraint_data = []
+ stereo_bond_constraint_data = []
+ planar_bond_constraint_data = []
+ planar_ring_5_constraint_data = []
+ planar_ring_6_constraint_data = []
+
+ # Convert parsed chains to tables
+ atom_idx = 0
+ res_idx = 0
+ asym_id = 0
+ sym_count = {}
+ chain_to_idx = {}
+
+ # Keep a mapping of (chain_name, residue_idx, atom_name) to atom_idx
+ atom_idx_map = {}
+
+ for asym_id, (chain_name, chain) in enumerate(chains.items()):
+ # Compute number of atoms and residues
+ res_num = len(chain.residues)
+ atom_num = sum(len(res.atoms) for res in chain.residues)
+
+ # Save protein chains for later
+ if chain.type == const.chain_type_ids["PROTEIN"]:
+ protein_chains.add(chain_name)
+
+ # Add affinity info
+ if chain.affinity and affinity_info is not None:
+ msg = "Cannot compute affinity for multiple ligands!"
+ raise ValueError(msg)
+
+ if chain.affinity:
+ affinity_info = AffinityInfo(
+ chain_id=asym_id,
+ mw=chain.affinity_mw,
+ )
+
+ # Find all copies of this chain in the assembly
+ entity_id = int(chain.entity)
+ sym_id = sym_count.get(entity_id, 0)
+ chain_data.append(
+ (
+ chain_name,
+ chain.type,
+ entity_id,
+ sym_id,
+ asym_id,
+ atom_idx,
+ atom_num,
+ res_idx,
+ res_num,
+ chain.cyclic_period,
+ )
+ )
+ chain_to_idx[chain_name] = asym_id
+ sym_count[entity_id] = sym_id + 1
+
+ # Add residue, atom, bond, data
+ for res in chain.residues:
+ atom_center = atom_idx + res.atom_center
+ atom_disto = atom_idx + res.atom_disto
+ res_data.append(
+ (
+ res.name,
+ res.type,
+ res.idx,
+ atom_idx,
+ len(res.atoms),
+ atom_center,
+ atom_disto,
+ res.is_standard,
+ res.is_present,
+ )
+ )
+
+ if res.rdkit_bounds_constraints is not None:
+ for constraint in res.rdkit_bounds_constraints:
+ rdkit_bounds_constraint_data.append( # noqa: PERF401
+ (
+ tuple(
+ c_atom_idx + atom_idx
+ for c_atom_idx in constraint.atom_idxs
+ ),
+ constraint.is_bond,
+ constraint.is_angle,
+ constraint.upper_bound,
+ constraint.lower_bound,
+ )
+ )
+ if res.chiral_atom_constraints is not None:
+ for constraint in res.chiral_atom_constraints:
+ chiral_atom_constraint_data.append( # noqa: PERF401
+ (
+ tuple(
+ c_atom_idx + atom_idx
+ for c_atom_idx in constraint.atom_idxs
+ ),
+ constraint.is_reference,
+ constraint.is_r,
+ )
+ )
+ if res.stereo_bond_constraints is not None:
+ for constraint in res.stereo_bond_constraints:
+ stereo_bond_constraint_data.append( # noqa: PERF401
+ (
+ tuple(
+ c_atom_idx + atom_idx
+ for c_atom_idx in constraint.atom_idxs
+ ),
+ constraint.is_check,
+ constraint.is_e,
+ )
+ )
+ if res.planar_bond_constraints is not None:
+ for constraint in res.planar_bond_constraints:
+ planar_bond_constraint_data.append( # noqa: PERF401
+ (
+ tuple(
+ c_atom_idx + atom_idx
+ for c_atom_idx in constraint.atom_idxs
+ ),
+ )
+ )
+ if res.planar_ring_5_constraints is not None:
+ for constraint in res.planar_ring_5_constraints:
+ planar_ring_5_constraint_data.append( # noqa: PERF401
+ (
+ tuple(
+ c_atom_idx + atom_idx
+ for c_atom_idx in constraint.atom_idxs
+ ),
+ )
+ )
+ if res.planar_ring_6_constraints is not None:
+ for constraint in res.planar_ring_6_constraints:
+ planar_ring_6_constraint_data.append( # noqa: PERF401
+ (
+ tuple(
+ c_atom_idx + atom_idx
+ for c_atom_idx in constraint.atom_idxs
+ ),
+ )
+ )
+
+ for bond in res.bonds:
+ atom_1 = atom_idx + bond.atom_1
+ atom_2 = atom_idx + bond.atom_2
+ bond_data.append(
+ (
+ asym_id,
+ asym_id,
+ res_idx,
+ res_idx,
+ atom_1,
+ atom_2,
+ bond.type,
+ )
+ )
+
+ for atom in res.atoms:
+ # Add atom to map
+ atom_idx_map[(chain_name, res.idx, atom.name)] = (
+ asym_id,
+ res_idx,
+ atom_idx,
+ )
+
+ # Add atom to data
+ atom_data.append(
+ (
+ atom.name,
+ atom.element,
+ atom.charge,
+ atom.coords,
+ atom.conformer,
+ atom.is_present,
+ atom.chirality,
+ )
+ )
+ atom_idx += 1
+
+ res_idx += 1
+
+ # Parse constraints
+ connections = []
+ pocket_constraints = []
+ contact_constraints = []
+ constraints = schema.get("constraints", [])
+ for constraint in constraints:
+ if "bond" in constraint:
+ if "atom1" not in constraint["bond"] or "atom2" not in constraint["bond"]:
+ msg = f"Bond constraint was not properly specified"
+ raise ValueError(msg)
+
+ c1, r1, a1 = tuple(constraint["bond"]["atom1"])
+ c2, r2, a2 = tuple(constraint["bond"]["atom2"])
+ c1, r1, a1 = atom_idx_map[(c1, r1 - 1, a1)] # 1-indexed
+ c2, r2, a2 = atom_idx_map[(c2, r2 - 1, a2)] # 1-indexed
+ connections.append((c1, c2, r1, r2, a1, a2))
+ elif "pocket" in constraint:
+ if (
+ "binder" not in constraint["pocket"]
+ or "contacts" not in constraint["pocket"]
+ ):
+ msg = f"Pocket constraint was not properly specified"
+ raise ValueError(msg)
+
+ if len(pocket_constraints) > 0 and not boltz_2:
+ msg = f"Only one pocket binders is supported in Boltz-1!"
+ raise ValueError(msg)
+
+ max_distance = constraint["pocket"].get("max_distance", 6.0)
+ if max_distance != 6.0 and not boltz_2:
+ msg = f"Max distance != 6.0 is not supported in Boltz-1!"
+ raise ValueError(msg)
+
+ binder = constraint["pocket"]["binder"]
+ binder = chain_to_idx[binder]
+
+ contacts = []
+ for chain_name, residue_index_or_atom_name in constraint["pocket"][
+ "contacts"
+ ]:
+ contact = token_spec_to_ids(
+ chain_name,
+ residue_index_or_atom_name,
+ chain_to_idx,
+ atom_idx_map,
+ chains,
+ )
+ contacts.append(contact)
+
+ force = constraint["pocket"].get("force", False)
+ pocket_constraints.append((binder, contacts, max_distance, force))
+ elif "contact" in constraint:
+ if (
+ "token1" not in constraint["contact"]
+ or "token2" not in constraint["contact"]
+ ):
+ msg = f"Contact constraint was not properly specified"
+ raise ValueError(msg)
+
+ if not boltz_2:
+ msg = f"Contact constraint is not supported in Boltz-1!"
+ raise ValueError(msg)
+
+ max_distance = constraint["contact"].get("max_distance", 6.0)
+
+ chain_name1, residue_index_or_atom_name1 = constraint["contact"]["token1"]
+ token1 = token_spec_to_ids(
+ chain_name1,
+ residue_index_or_atom_name1,
+ chain_to_idx,
+ atom_idx_map,
+ chains,
+ )
+ chain_name2, residue_index_or_atom_name2 = constraint["contact"]["token2"]
+ token2 = token_spec_to_ids(
+ chain_name2,
+ residue_index_or_atom_name2,
+ chain_to_idx,
+ atom_idx_map,
+ chains,
+ )
+ force = constraint["contact"].get("force", False)
+
+ contact_constraints.append((token1, token2, max_distance, force))
+ else:
+ msg = f"Invalid constraint: {constraint}"
+ raise ValueError(msg)
+
+ # Get protein sequences in this YAML
+ protein_seqs = {name: chains[name].sequence for name in protein_chains}
+
+ # Parse templates
+ template_schema = schema.get("templates", [])
+ if template_schema and not boltz_2:
+ msg = "Templates are not supported in Boltz 1.0!"
+ raise ValueError(msg)
+
+ templates = {}
+ template_records = []
+ for template in template_schema:
+ if "cif" not in template:
+ msg = "Template was not properly specified, missing CIF path!"
+ raise ValueError(msg)
+
+ path = template["cif"]
+ template_id = Path(path).stem
+ chain_ids = template.get("chain_id", None)
+ template_chain_ids = template.get("template_id", None)
+
+ # Check validity of input
+ matched = False
+
+ if chain_ids is not None and not isinstance(chain_ids, list):
+ chain_ids = [chain_ids]
+ if template_chain_ids is not None and not isinstance(template_chain_ids, list):
+ template_chain_ids = [template_chain_ids]
+
+ if (
+ template_chain_ids is not None
+ and chain_ids is not None
+ ):
+
+ if len(template_chain_ids) == len(chain_ids):
+ if len(template_chain_ids) > 0 and len(chain_ids) > 0:
+ matched = True
+ else:
+ msg = (
+ "When providing both the chain_id and template_id, the number of"
+ "template_ids provided must match the number of chain_ids!"
+ )
+ raise ValueError(msg)
+
+ # Get relevant chains ids
+ if chain_ids is None:
+ chain_ids = list(protein_chains)
+
+ for chain_id in chain_ids:
+ if chain_id not in protein_chains:
+ msg = (
+ f"Chain {chain_id} assigned for template"
+ f"{template_id} is not one of the protein chains!"
+ )
+ raise ValueError(msg)
+
+ # Get relevant template chain ids
+ parsed_template = parse_mmcif(
+ path,
+ mols=ccd,
+ moldir=mol_dir,
+ use_assembly=False,
+ compute_interfaces=False,
+ )
+ template_proteins = {
+ str(c["name"])
+ for c in parsed_template.data.chains
+ if c["mol_type"] == const.chain_type_ids["PROTEIN"]
+ }
+ if template_chain_ids is None:
+ template_chain_ids = list(template_proteins)
+
+ for chain_id in template_chain_ids:
+ if chain_id not in template_proteins:
+ msg = (
+ f"Template chain {chain_id} assigned for template"
+ f"{template_id} is not one of the protein chains!"
+ )
+ raise ValueError(msg)
+
+ force = template.get("force", False)
+ if force:
+ if "threshold" in template:
+ threshold = template["threshold"]
+ else:
+ msg = f"Template {template_id} must have threshold specified if force is set to True"
+ raise ValueError(msg)
+ else:
+ threshold = float("inf")
+ # Compute template records
+
+ if matched:
+ template_records.extend(
+ get_template_records_from_matching(
+ template_id=template_id,
+ chain_ids=chain_ids,
+ sequences=protein_seqs,
+ template_chain_ids=template_chain_ids,
+ template_sequences=parsed_template.sequences,
+ force=force,
+ threshold=threshold,
+ )
+ )
+ else:
+ template_records.extend(
+ get_template_records_from_search(
+ template_id=template_id,
+ chain_ids=chain_ids,
+ sequences=protein_seqs,
+ template_chain_ids=template_chain_ids,
+ template_sequences=parsed_template.sequences,
+ force=force,
+ threshold=threshold,
+ )
+ )
+ # Save template
+ templates[template_id] = parsed_template.data
+
+ # Convert into datatypes
+ residues = np.array(res_data, dtype=Residue)
+ chains = np.array(chain_data, dtype=Chain)
+ interfaces = np.array([], dtype=Interface)
+ mask = np.ones(len(chain_data), dtype=bool)
+ rdkit_bounds_constraints = np.array(
+ rdkit_bounds_constraint_data, dtype=RDKitBoundsConstraint
+ )
+ chiral_atom_constraints = np.array(
+ chiral_atom_constraint_data, dtype=ChiralAtomConstraint
+ )
+ stereo_bond_constraints = np.array(
+ stereo_bond_constraint_data, dtype=StereoBondConstraint
+ )
+ planar_bond_constraints = np.array(
+ planar_bond_constraint_data, dtype=PlanarBondConstraint
+ )
+ planar_ring_5_constraints = np.array(
+ planar_ring_5_constraint_data, dtype=PlanarRing5Constraint
+ )
+ planar_ring_6_constraints = np.array(
+ planar_ring_6_constraint_data, dtype=PlanarRing6Constraint
+ )
+
+ if boltz_2:
+ atom_data = [(a[0], a[3], a[5], 0.0, 1.0) for a in atom_data]
+ connections = [(*c, const.bond_type_ids["COVALENT"]) for c in connections]
+ bond_data = bond_data + connections
+ atoms = np.array(atom_data, dtype=AtomV2)
+ bonds = np.array(bond_data, dtype=BondV2)
+ coords = [(x,) for x in atoms["coords"]]
+ coords = np.array(coords, Coords)
+ ensemble = np.array([(0, len(coords))], dtype=Ensemble)
+ data = StructureV2(
+ atoms=atoms,
+ bonds=bonds,
+ residues=residues,
+ chains=chains,
+ interfaces=interfaces,
+ mask=mask,
+ coords=coords,
+ ensemble=ensemble,
+ )
+ else:
+ bond_data = [(b[4], b[5], b[6]) for b in bond_data]
+ atom_data = [(convert_atom_name(a[0]), *a[1:]) for a in atom_data]
+ atoms = np.array(atom_data, dtype=Atom)
+ bonds = np.array(bond_data, dtype=Bond)
+ connections = np.array(connections, dtype=Connection)
+ data = Structure(
+ atoms=atoms,
+ bonds=bonds,
+ residues=residues,
+ chains=chains,
+ connections=connections,
+ interfaces=interfaces,
+ mask=mask,
+ )
+
+ # Create metadata
+ struct_info = StructureInfo(num_chains=len(chains))
+ chain_infos = []
+ for chain in chains:
+ chain_info = ChainInfo(
+ chain_id=int(chain["asym_id"]),
+ chain_name=chain["name"],
+ mol_type=int(chain["mol_type"]),
+ cluster_id=-1,
+ msa_id=chain_to_msa[chain["name"]],
+ num_residues=int(chain["res_num"]),
+ valid=True,
+ entity_id=int(chain["entity_id"]),
+ )
+ chain_infos.append(chain_info)
+
+ options = InferenceOptions(
+ pocket_constraints=pocket_constraints, contact_constraints=contact_constraints
+ )
+ record = Record(
+ id=name,
+ structure=struct_info,
+ chains=chain_infos,
+ interfaces=[],
+ inference_options=options,
+ templates=template_records,
+ affinity=affinity_info,
+ )
+
+ residue_constraints = ResidueConstraints(
+ rdkit_bounds_constraints=rdkit_bounds_constraints,
+ chiral_atom_constraints=chiral_atom_constraints,
+ stereo_bond_constraints=stereo_bond_constraints,
+ planar_bond_constraints=planar_bond_constraints,
+ planar_ring_5_constraints=planar_ring_5_constraints,
+ planar_ring_6_constraints=planar_ring_6_constraints,
+ )
+ return Target(
+ record=record,
+ structure=data,
+ sequences=entity_to_seq,
+ residue_constraints=residue_constraints,
+ templates=templates,
+ extra_mols=extra_mols,
+ )
+
+
+def standardize(smiles: str) -> Optional[str]:
+ """Standardize a molecule and return its SMILES and a flag indicating whether the molecule is valid.
+ This version has exception handling, which the original in mol-finder/data doesn't have. I didn't change the mol-finder/data
+ since there are a lot of other functions that depend on it and I didn't want to break them.
+ """
+ LARGEST_FRAGMENT_CHOOSER = rdMolStandardize.LargestFragmentChooser()
+
+ mol = Chem.MolFromSmiles(smiles, sanitize=False)
+
+ exclude = exclude_flag(mol, includeRDKitSanitization=False)
+
+ if exclude:
+ raise ValueError("Molecule is excluded")
+
+ # Standardize with ChEMBL data curation pipeline. During standardization, the molecule may be broken
+ # Choose molecule with largest component
+ mol = LARGEST_FRAGMENT_CHOOSER.choose(mol)
+ # Standardize with ChEMBL data curation pipeline. During standardization, the molecule may be broken
+ mol = standardize_mol(mol)
+ smiles = Chem.MolToSmiles(mol)
+
+ # Check if molecule can be parsed by RDKit (in rare cases, the molecule may be broken during standardization)
+ if Chem.MolFromSmiles(smiles) is None:
+ raise ValueError("Molecule is broken")
+
+ return smiles
diff --git a/forks/boltz/src/boltz/data/parse/yaml.py b/forks/boltz/src/boltz/data/parse/yaml.py
new file mode 100644
index 00000000..a08b7abf
--- /dev/null
+++ b/forks/boltz/src/boltz/data/parse/yaml.py
@@ -0,0 +1,68 @@
+from pathlib import Path
+
+import yaml
+from rdkit.Chem.rdchem import Mol
+
+from boltz.data.parse.schema import parse_boltz_schema
+from boltz.data.types import Target
+
+
+def parse_yaml(
+ path: Path,
+ ccd: dict[str, Mol],
+ mol_dir: Path,
+ boltz2: bool = False,
+) -> Target:
+ """Parse a Boltz input yaml / json.
+
+ The input file should be a yaml file with the following format:
+
+ sequences:
+ - protein:
+ id: A
+ sequence: "MADQLTEEQIAEFKEAFSLF"
+ - protein:
+ id: [B, C]
+ sequence: "AKLSILPWGHC"
+ - rna:
+ id: D
+ sequence: "GCAUAGC"
+ - ligand:
+ id: E
+ smiles: "CC1=CC=CC=C1"
+ - ligand:
+ id: [F, G]
+ ccd: []
+ constraints:
+ - bond:
+ atom1: [A, 1, CA]
+ atom2: [A, 2, N]
+ - pocket:
+ binder: E
+ contacts: [[B, 1], [B, 2]]
+ templates:
+ - path: /path/to/template.pdb
+ ids: [A] # optional, specify which chains to template
+
+ version: 1
+
+ Parameters
+ ----------
+ path : Path
+ Path to the YAML input format.
+ components : Dict
+ Dictionary of CCD components.
+ boltz2 : bool
+ Whether to parse the input for Boltz2.
+
+ Returns
+ -------
+ Target
+ The parsed target.
+
+ """
+ with path.open("r") as file:
+ data = yaml.safe_load(file)
+
+ name = path.stem
+ return parse_boltz_schema(name, data, ccd, mol_dir, boltz2)
diff --git a/forks/boltz/src/boltz/data/sample/__init__.py b/forks/boltz/src/boltz/data/sample/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/data/sample/cluster.py b/forks/boltz/src/boltz/data/sample/cluster.py
new file mode 100644
index 00000000..fb5c2e66
--- /dev/null
+++ b/forks/boltz/src/boltz/data/sample/cluster.py
@@ -0,0 +1,283 @@
+from typing import Dict, Iterator, List
+
+import numpy as np
+from numpy.random import RandomState
+
+from boltz.data import const
+from boltz.data.types import ChainInfo, InterfaceInfo, Record
+from boltz.data.sample.sampler import Sample, Sampler
+
+
+def get_chain_cluster(chain: ChainInfo, record: Record) -> str: # noqa: ARG001
+ """Get the cluster id for a chain.
+
+ Parameters
+ ----------
+ chain : ChainInfo
+ The chain id to get the cluster id for.
+ record : Record
+ The record the interface is part of.
+
+ Returns
+ -------
+ str
+ The cluster id of the chain.
+
+ """
+ return chain.cluster_id
+
+
+def get_interface_cluster(interface: InterfaceInfo, record: Record) -> str:
+ """Get the cluster id for an interface.
+
+ Parameters
+ ----------
+ interface : InterfaceInfo
+ The interface to get the cluster id for.
+ record : Record
+ The record the interface is part of.
+
+ Returns
+ -------
+ str
+ The cluster id of the interface.
+
+ """
+ chain1 = record.chains[interface.chain_1]
+ chain2 = record.chains[interface.chain_2]
+
+ cluster_1 = str(chain1.cluster_id)
+ cluster_2 = str(chain2.cluster_id)
+
+ cluster_id = (cluster_1, cluster_2)
+ cluster_id = tuple(sorted(cluster_id))
+
+ return cluster_id
+
+
+def get_chain_weight(
+ chain: ChainInfo,
+ record: Record, # noqa: ARG001
+ clusters: Dict[str, int],
+ beta_chain: float,
+ alpha_prot: float,
+ alpha_nucl: float,
+ alpha_ligand: float,
+) -> float:
+ """Get the weight of a chain.
+
+ Parameters
+ ----------
+ chain : ChainInfo
+ The chain to get the weight for.
+ record : Record
+ The record the chain is part of.
+ clusters : Dict[str, int]
+ The cluster sizes.
+ beta_chain : float
+ The beta value for chains.
+ alpha_prot : float
+ The alpha value for proteins.
+ alpha_nucl : float
+ The alpha value for nucleic acids.
+ alpha_ligand : float
+ The alpha value for ligands.
+
+ Returns
+ -------
+ float
+ The weight of the chain.
+
+ """
+ prot_id = const.chain_type_ids["PROTEIN"]
+ rna_id = const.chain_type_ids["RNA"]
+ dna_id = const.chain_type_ids["DNA"]
+ ligand_id = const.chain_type_ids["NONPOLYMER"]
+
+ weight = beta_chain / clusters[chain.cluster_id]
+ if chain.mol_type == prot_id:
+ weight *= alpha_prot
+ elif chain.mol_type in [rna_id, dna_id]:
+ weight *= alpha_nucl
+ elif chain.mol_type == ligand_id:
+ weight *= alpha_ligand
+
+ return weight
+
+
+def get_interface_weight(
+ interface: InterfaceInfo,
+ record: Record,
+ clusters: Dict[str, int],
+ beta_interface: float,
+ alpha_prot: float,
+ alpha_nucl: float,
+ alpha_ligand: float,
+) -> float:
+ """Get the weight of an interface.
+
+ Parameters
+ ----------
+ interface : InterfaceInfo
+ The interface to get the weight for.
+ record : Record
+ The record the interface is part of.
+ clusters : Dict[str, int]
+ The cluster sizes.
+ beta_interface : float
+ The beta value for interfaces.
+ alpha_prot : float
+ The alpha value for proteins.
+ alpha_nucl : float
+ The alpha value for nucleic acids.
+ alpha_ligand : float
+ The alpha value for ligands.
+
+ Returns
+ -------
+ float
+ The weight of the interface.
+
+ """
+ prot_id = const.chain_type_ids["PROTEIN"]
+ rna_id = const.chain_type_ids["RNA"]
+ dna_id = const.chain_type_ids["DNA"]
+ ligand_id = const.chain_type_ids["NONPOLYMER"]
+
+ chain1 = record.chains[interface.chain_1]
+ chain2 = record.chains[interface.chain_2]
+
+ n_prot = (chain1.mol_type) == prot_id
+ n_nuc = chain1.mol_type in [rna_id, dna_id]
+ n_ligand = chain1.mol_type == ligand_id
+
+ n_prot += chain2.mol_type == prot_id
+ n_nuc += chain2.mol_type in [rna_id, dna_id]
+ n_ligand += chain2.mol_type == ligand_id
+
+ weight = beta_interface / clusters[get_interface_cluster(interface, record)]
+ weight *= alpha_prot * n_prot + alpha_nucl * n_nuc + alpha_ligand * n_ligand
+ return weight
+
+
+class ClusterSampler(Sampler):
+ """The weighted sampling approach, as described in AF3.
+
+ Each chain / interface is given a weight according
+ to the following formula, and sampled accordingly:
+
+ w = b / n_clust *(a_prot * n_prot + a_nuc * n_nuc
+ + a_ligand * n_ligand)
+
+ """
+
+ def __init__(
+ self,
+ alpha_prot: float = 3.0,
+ alpha_nucl: float = 3.0,
+ alpha_ligand: float = 1.0,
+ beta_chain: float = 0.5,
+ beta_interface: float = 1.0,
+ ) -> None:
+ """Initialize the sampler.
+
+ Parameters
+ ----------
+ alpha_prot : float, optional
+ The alpha value for proteins.
+ alpha_nucl : float, optional
+ The alpha value for nucleic acids.
+ alpha_ligand : float, optional
+ The alpha value for ligands.
+ beta_chain : float, optional
+ The beta value for chains.
+ beta_interface : float, optional
+ The beta value for interfaces.
+
+ """
+ self.alpha_prot = alpha_prot
+ self.alpha_nucl = alpha_nucl
+ self.alpha_ligand = alpha_ligand
+ self.beta_chain = beta_chain
+ self.beta_interface = beta_interface
+
+ def sample(self, records: List[Record], random: RandomState) -> Iterator[Sample]: # noqa: C901, PLR0912
+ """Sample a structure from the dataset infinitely.
+
+ Parameters
+ ----------
+ records : List[Record]
+ The records to sample from.
+ random : RandomState
+ The random state for reproducibility.
+
+ Yields
+ ------
+ Sample
+ A data sample.
+
+ """
+ # Compute chain cluster sizes
+ chain_clusters: Dict[str, int] = {}
+ for record in records:
+ for chain in record.chains:
+ if not chain.valid:
+ continue
+ cluster_id = get_chain_cluster(chain, record)
+ if cluster_id not in chain_clusters:
+ chain_clusters[cluster_id] = 0
+ chain_clusters[cluster_id] += 1
+
+ # Compute interface clusters sizes
+ interface_clusters: Dict[str, int] = {}
+ for record in records:
+ for interface in record.interfaces:
+ if not interface.valid:
+ continue
+ cluster_id = get_interface_cluster(interface, record)
+ if cluster_id not in interface_clusters:
+ interface_clusters[cluster_id] = 0
+ interface_clusters[cluster_id] += 1
+
+ # Compute weights
+ items, weights = [], []
+ for record in records:
+ for chain_id, chain in enumerate(record.chains):
+ if not chain.valid:
+ continue
+ weight = get_chain_weight(
+ chain,
+ record,
+ chain_clusters,
+ self.beta_chain,
+ self.alpha_prot,
+ self.alpha_nucl,
+ self.alpha_ligand,
+ )
+ items.append((record, 0, chain_id))
+ weights.append(weight)
+
+ for int_id, interface in enumerate(record.interfaces):
+ if not interface.valid:
+ continue
+ weight = get_interface_weight(
+ interface,
+ record,
+ interface_clusters,
+ self.beta_interface,
+ self.alpha_prot,
+ self.alpha_nucl,
+ self.alpha_ligand,
+ )
+ items.append((record, 1, int_id))
+ weights.append(weight)
+
+ # Sample infinitely
+ weights = np.array(weights) / np.sum(weights)
+ while True:
+ item_idx = random.choice(len(items), p=weights)
+ record, kind, index = items[item_idx]
+ if kind == 0:
+ yield Sample(record=record, chain_id=index)
+ else:
+ yield Sample(record=record, interface_id=index)
diff --git a/forks/boltz/src/boltz/data/sample/distillation.py b/forks/boltz/src/boltz/data/sample/distillation.py
new file mode 100644
index 00000000..9314f510
--- /dev/null
+++ b/forks/boltz/src/boltz/data/sample/distillation.py
@@ -0,0 +1,57 @@
+from typing import Iterator, List
+
+from numpy.random import RandomState
+
+from boltz.data.types import Record
+from boltz.data.sample.sampler import Sample, Sampler
+
+
+class DistillationSampler(Sampler):
+ """A sampler for monomer distillation data."""
+
+ def __init__(self, small_size: int = 200, small_prob: float = 0.01) -> None:
+ """Initialize the sampler.
+
+ Parameters
+ ----------
+ small_size : int, optional
+ The maximum size to be considered small.
+ small_prob : float, optional
+ The probability of sampling a small item.
+
+ """
+ self._size = small_size
+ self._prob = small_prob
+
+ def sample(self, records: List[Record], random: RandomState) -> Iterator[Sample]:
+ """Sample a structure from the dataset infinitely.
+
+ Parameters
+ ----------
+ records : List[Record]
+ The records to sample from.
+ random : RandomState
+ The random state for reproducibility.
+
+ Yields
+ ------
+ Sample
+ A data sample.
+
+ """
+ # Remove records with invalid chains
+ records = [r for r in records if r.chains[0].valid]
+
+ # Split in small and large proteins. We assume that there is only
+ # one chain per record, as is the case for monomer distillation
+ small = [r for r in records if r.chains[0].num_residues <= self._size]
+ large = [r for r in records if r.chains[0].num_residues > self._size]
+
+ # Sample infinitely
+ while True:
+ # Sample small or large
+ samples = small if random.rand() < self._prob else large
+
+ # Sample item from the list
+ index = random.randint(0, len(samples))
+ yield Sample(record=samples[index])
diff --git a/forks/boltz/src/boltz/data/sample/random.py b/forks/boltz/src/boltz/data/sample/random.py
new file mode 100644
index 00000000..e2ee2314
--- /dev/null
+++ b/forks/boltz/src/boltz/data/sample/random.py
@@ -0,0 +1,39 @@
+from dataclasses import replace
+from typing import Iterator, List
+
+from numpy.random import RandomState
+
+from boltz.data.types import Record
+from boltz.data.sample.sampler import Sample, Sampler
+
+
+class RandomSampler(Sampler):
+ """A simple random sampler with replacement."""
+
+ def sample(self, records: List[Record], random: RandomState) -> Iterator[Sample]:
+ """Sample a structure from the dataset infinitely.
+
+ Parameters
+ ----------
+ records : List[Record]
+ The records to sample from.
+ random : RandomState
+ The random state for reproducibility.
+
+ Yields
+ ------
+ Sample
+ A data sample.
+
+ """
+ while True:
+ # Sample item from the list
+ index = random.randint(0, len(records))
+ record = records[index]
+
+ # Remove invalid chains and interfaces
+ chains = [c for c in record.chains if c.valid]
+ interfaces = [i for i in record.interfaces if i.valid]
+ record = replace(record, chains=chains, interfaces=interfaces)
+
+ yield Sample(record=record)
diff --git a/forks/boltz/src/boltz/data/sample/sampler.py b/forks/boltz/src/boltz/data/sample/sampler.py
new file mode 100644
index 00000000..6c6ab6dd
--- /dev/null
+++ b/forks/boltz/src/boltz/data/sample/sampler.py
@@ -0,0 +1,49 @@
+from abc import ABC, abstractmethod
+from dataclasses import dataclass
+from typing import Iterator, List, Optional
+
+from numpy.random import RandomState
+
+from boltz.data.types import Record
+
+
+@dataclass
+class Sample:
+ """A sample with optional chain and interface IDs.
+
+ Attributes
+ ----------
+ record : Record
+ The record.
+ chain_id : Optional[int]
+ The chain ID.
+ interface_id : Optional[int]
+ The interface ID.
+ """
+
+ record: Record
+ chain_id: Optional[int] = None
+ interface_id: Optional[int] = None
+
+
+class Sampler(ABC):
+ """Abstract base class for samplers."""
+
+ @abstractmethod
+ def sample(self, records: List[Record], random: RandomState) -> Iterator[Sample]:
+ """Sample a structure from the dataset infinitely.
+
+ Parameters
+ ----------
+ records : List[Record]
+ The records to sample from.
+ random : RandomState
+ The random state for reproducibility.
+
+ Yields
+ ------
+ Sample
+ A data sample.
+
+ """
+ raise NotImplementedError
diff --git a/forks/boltz/src/boltz/data/tokenize/__init__.py b/forks/boltz/src/boltz/data/tokenize/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/data/tokenize/boltz.py b/forks/boltz/src/boltz/data/tokenize/boltz.py
new file mode 100644
index 00000000..06c12645
--- /dev/null
+++ b/forks/boltz/src/boltz/data/tokenize/boltz.py
@@ -0,0 +1,217 @@
+from dataclasses import dataclass
+
+import numpy as np
+
+from boltz.data import const
+from boltz.data.tokenize.tokenizer import Tokenizer
+from boltz.data.types import Input, Token, TokenBond, Tokenized
+
+
+@dataclass
+class TokenData:
+ """TokenData datatype."""
+
+ token_idx: int
+ atom_idx: int
+ atom_num: int
+ res_idx: int
+ res_type: int
+ sym_id: int
+ asym_id: int
+ entity_id: int
+ mol_type: int
+ center_idx: int
+ disto_idx: int
+ center_coords: np.ndarray
+ disto_coords: np.ndarray
+ resolved_mask: bool
+ disto_mask: bool
+ cyclic_period: int
+
+
+def token_astuple(token: TokenData) -> tuple:
+ """Convert a TokenData object to a tuple."""
+ return (
+ token.token_idx,
+ token.atom_idx,
+ token.atom_num,
+ token.res_idx,
+ token.res_type,
+ token.sym_id,
+ token.asym_id,
+ token.entity_id,
+ token.mol_type,
+ token.center_idx,
+ token.disto_idx,
+ token.center_coords,
+ token.disto_coords,
+ token.resolved_mask,
+ token.disto_mask,
+ token.cyclic_period,
+ )
+
+
+class BoltzTokenizer(Tokenizer):
+ """Tokenize an input structure for training."""
+
+ def tokenize(self, data: Input) -> Tokenized:
+ """Tokenize the input data.
+
+ Parameters
+ ----------
+ data : Input
+ The input data.
+
+ Returns
+ -------
+ Tokenized
+ The tokenized data.
+
+ """
+ # Get structure data
+ struct = data.structure
+
+ # Create token data
+ token_data = []
+
+ # Keep track of atom_idx to token_idx
+ token_idx = 0
+ atom_to_token = {}
+
+ # Filter to valid chains only
+ chains = struct.chains[struct.mask]
+
+ for chain in chains:
+ # Get residue indices
+ res_start = chain["res_idx"]
+ res_end = chain["res_idx"] + chain["res_num"]
+
+ for res in struct.residues[res_start:res_end]:
+ # Get atom indices
+ atom_start = res["atom_idx"]
+ atom_end = res["atom_idx"] + res["atom_num"]
+
+ # Standard residues are tokens
+ if res["is_standard"]:
+ # Get center and disto atoms
+ center = struct.atoms[res["atom_center"]]
+ disto = struct.atoms[res["atom_disto"]]
+
+ # Token is present if centers are
+ is_present = res["is_present"] & center["is_present"]
+ is_disto_present = res["is_present"] & disto["is_present"]
+
+ # Apply chain transformation
+ c_coords = center["coords"]
+ d_coords = disto["coords"]
+
+ # Create token
+ token = TokenData(
+ token_idx=token_idx,
+ atom_idx=res["atom_idx"],
+ atom_num=res["atom_num"],
+ res_idx=res["res_idx"],
+ res_type=res["res_type"],
+ sym_id=chain["sym_id"],
+ asym_id=chain["asym_id"],
+ entity_id=chain["entity_id"],
+ mol_type=chain["mol_type"],
+ center_idx=res["atom_center"],
+ disto_idx=res["atom_disto"],
+ center_coords=c_coords,
+ disto_coords=d_coords,
+ resolved_mask=is_present,
+ disto_mask=is_disto_present,
+ cyclic_period=chain["cyclic_period"],
+ )
+ token_data.append(token_astuple(token))
+
+ # Update atom_idx to token_idx
+ atom_to_token.update(
+ dict.fromkeys(range(atom_start, atom_end), token_idx))
+
+ token_idx += 1
+
+ # Non-standard are tokenized per atom
+ else:
+ # We use the unk protein token as res_type
+ unk_token = const.unk_token["PROTEIN"]
+ unk_id = const.token_ids[unk_token]
+
+ # Get atom coordinates
+ atom_data = struct.atoms[atom_start:atom_end]
+ atom_coords = atom_data["coords"]
+
+ # Tokenize each atom
+ for i, atom in enumerate(atom_data):
+ # Token is present if atom is
+ is_present = res["is_present"] & atom["is_present"]
+ index = atom_start + i
+
+ # Create token
+ token = TokenData(
+ token_idx=token_idx,
+ atom_idx=index,
+ atom_num=1,
+ res_idx=res["res_idx"],
+ res_type=unk_id,
+ sym_id=chain["sym_id"],
+ asym_id=chain["asym_id"],
+ entity_id=chain["entity_id"],
+ mol_type=chain["mol_type"],
+ center_idx=index,
+ disto_idx=index,
+ center_coords=atom_coords[i],
+ disto_coords=atom_coords[i],
+ resolved_mask=is_present,
+ disto_mask=is_present,
+ cyclic_period=chain[
+ "cyclic_period"
+ ], # Enforced to be False in chain parser
+ )
+ token_data.append(token_astuple(token))
+
+ # Update atom_idx to token_idx
+ atom_to_token[index] = token_idx
+ token_idx += 1
+
+ # Create token bonds
+ token_bonds = []
+
+ # Add atom-atom bonds from ligands
+ for bond in struct.bonds:
+ if (
+ bond["atom_1"] not in atom_to_token
+ or bond["atom_2"] not in atom_to_token
+ ):
+ continue
+ token_bond = (
+ atom_to_token[bond["atom_1"]],
+ atom_to_token[bond["atom_2"]],
+ )
+ token_bonds.append(token_bond)
+
+ # Add connection bonds (covalent)
+ for conn in struct.connections:
+ if (
+ conn["atom_1"] not in atom_to_token
+ or conn["atom_2"] not in atom_to_token
+ ):
+ continue
+ token_bond = (
+ atom_to_token[conn["atom_1"]],
+ atom_to_token[conn["atom_2"]],
+ )
+ token_bonds.append(token_bond)
+
+ token_data = np.array(token_data, dtype=Token)
+ token_bonds = np.array(token_bonds, dtype=TokenBond)
+ tokenized = Tokenized(
+ tokens=token_data,
+ bonds=token_bonds,
+ structure=data.structure,
+ msa=data.msa,
+ record=data.record,
+ residue_constraints=data.residue_constraints,
+ )
+ return tokenized
diff --git a/forks/boltz/src/boltz/data/tokenize/boltz2.py b/forks/boltz/src/boltz/data/tokenize/boltz2.py
new file mode 100644
index 00000000..7371d6ae
--- /dev/null
+++ b/forks/boltz/src/boltz/data/tokenize/boltz2.py
@@ -0,0 +1,426 @@
+from dataclasses import dataclass
+from typing import Optional
+
+import numpy as np
+
+from boltz.data import const
+from boltz.data.tokenize.tokenizer import Tokenizer
+from boltz.data.types import (
+ AffinityInfo,
+ Input,
+ StructureV2,
+ TokenBondV2,
+ Tokenized,
+ TokenV2,
+)
+
+
+@dataclass
+class TokenData:
+ """TokenData datatype."""
+
+ token_idx: int
+ atom_idx: int
+ atom_num: int
+ res_idx: int
+ res_type: int
+ res_name: str
+ sym_id: int
+ asym_id: int
+ entity_id: int
+ mol_type: int
+ center_idx: int
+ disto_idx: int
+ center_coords: np.ndarray
+ disto_coords: np.ndarray
+ resolved_mask: bool
+ disto_mask: bool
+ modified: bool
+ frame_rot: np.ndarray
+ frame_t: np.ndarray
+ frame_mask: bool
+ cyclic_period: int
+ affinity_mask: bool = False
+
+
+def token_astuple(token: TokenData) -> tuple:
+ """Convert a TokenData object to a tuple."""
+ return (
+ token.token_idx,
+ token.atom_idx,
+ token.atom_num,
+ token.res_idx,
+ token.res_type,
+ token.res_name,
+ token.sym_id,
+ token.asym_id,
+ token.entity_id,
+ token.mol_type,
+ token.center_idx,
+ token.disto_idx,
+ token.center_coords,
+ token.disto_coords,
+ token.resolved_mask,
+ token.disto_mask,
+ token.modified,
+ token.frame_rot,
+ token.frame_t,
+ token.frame_mask,
+ token.cyclic_period,
+ token.affinity_mask,
+ )
+
+
+def compute_frame(
+ n: np.ndarray,
+ ca: np.ndarray,
+ c: np.ndarray,
+) -> tuple[np.ndarray, np.ndarray]:
+ """Compute the frame for a residue.
+
+ Parameters
+ ----------
+ n : np.ndarray
+ The N atom.
+ ca : np.ndarray
+ The C atom.
+ c : np.ndarray
+ The CA atom.
+
+ Returns
+ -------
+ np.ndarray
+ The frame.
+
+ """
+ v1 = c - ca
+ v2 = n - ca
+ e1 = v1 / (np.linalg.norm(v1) + 1e-10)
+ u2 = v2 - e1 * np.dot(e1.T, v2)
+ e2 = u2 / (np.linalg.norm(u2) + 1e-10)
+ e3 = np.cross(e1, e2)
+ rot = np.column_stack([e1, e2, e3])
+ t = ca
+ return rot, t
+
+
+def get_unk_token(chain: np.ndarray) -> int:
+ """Get the unk token for a residue.
+
+ Parameters
+ ----------
+ chain : np.ndarray
+ The chain.
+
+ Returns
+ -------
+ int
+ The unk token.
+
+ """
+ if chain["mol_type"] == const.chain_type_ids["DNA"]:
+ unk_token = const.unk_token["DNA"]
+ elif chain["mol_type"] == const.chain_type_ids["RNA"]:
+ unk_token = const.unk_token["RNA"]
+ else:
+ unk_token = const.unk_token["PROTEIN"]
+
+ res_id = const.token_ids[unk_token]
+ return res_id
+
+
+def tokenize_structure( # noqa: C901, PLR0915
+ struct: StructureV2,
+ affinity: Optional[AffinityInfo] = None,
+) -> tuple[np.ndarray, np.ndarray]:
+ """Tokenize a structure.
+
+ Parameters
+ ----------
+ struct : StructureV2
+ The structure to tokenize.
+ affinity : Optional[AffinityInfo]
+ The affinity information.
+
+ Returns
+ -------
+ np.ndarray
+ The tokenized data.
+ np.ndarray
+ The tokenized bonds.
+
+ """
+ # Create token data
+ token_data = []
+
+ # Keep track of atom_idx to token_idx
+ token_idx = 0
+ atom_to_token = {}
+
+ # Filter to valid chains only
+ chains = struct.chains[struct.mask]
+
+ # Ensemble atom id start in coords table.
+ # For cropper and other operations, hardcoded to 0th conformer.
+ offset = struct.ensemble[0]["atom_coord_idx"]
+
+ for chain in chains:
+ # Get residue indices
+ res_start = chain["res_idx"]
+ res_end = chain["res_idx"] + chain["res_num"]
+ is_protein = chain["mol_type"] == const.chain_type_ids["PROTEIN"]
+ affinity_mask = (affinity is not None) and (
+ int(chain["asym_id"]) == int(affinity.chain_id)
+ )
+
+ for res in struct.residues[res_start:res_end]:
+ # Get atom indices
+ atom_start = res["atom_idx"]
+ atom_end = res["atom_idx"] + res["atom_num"]
+
+ # Standard residues are tokens
+ if res["is_standard"]:
+ # Get center and disto atoms
+ center = struct.atoms[res["atom_center"]]
+ disto = struct.atoms[res["atom_disto"]]
+
+ # Token is present if centers are
+ is_present = res["is_present"] & center["is_present"]
+ is_disto_present = res["is_present"] & disto["is_present"]
+
+ # Apply chain transformation
+ # Apply chain transformation
+ c_coords = struct.coords[offset + res["atom_center"]]["coords"]
+ d_coords = struct.coords[offset + res["atom_disto"]]["coords"]
+
+ # If protein, compute frame, only used for templates
+ frame_rot = np.eye(3).flatten()
+ frame_t = np.zeros(3)
+ frame_mask = False
+
+ if is_protein:
+ # Get frame atoms
+ atom_st = res["atom_idx"]
+ atom_en = res["atom_idx"] + res["atom_num"]
+ atoms = struct.atoms[atom_st:atom_en]
+
+ # Atoms are always in the order N, CA, C
+ atom_n = atoms[0]
+ atom_ca = atoms[1]
+ atom_c = atoms[2]
+
+ # Compute frame and mask
+ frame_mask = atom_ca["is_present"]
+ frame_mask &= atom_c["is_present"]
+ frame_mask &= atom_n["is_present"]
+ frame_mask = bool(frame_mask)
+ if frame_mask:
+ frame_rot, frame_t = compute_frame(
+ atom_n["coords"],
+ atom_ca["coords"],
+ atom_c["coords"],
+ )
+ frame_rot = frame_rot.flatten()
+
+ # Create token
+ token = TokenData(
+ token_idx=token_idx,
+ atom_idx=res["atom_idx"],
+ atom_num=res["atom_num"],
+ res_idx=res["res_idx"],
+ res_type=res["res_type"],
+ res_name=res["name"],
+ sym_id=chain["sym_id"],
+ asym_id=chain["asym_id"],
+ entity_id=chain["entity_id"],
+ mol_type=chain["mol_type"],
+ center_idx=res["atom_center"],
+ disto_idx=res["atom_disto"],
+ center_coords=c_coords,
+ disto_coords=d_coords,
+ resolved_mask=is_present,
+ disto_mask=is_disto_present,
+ modified=False,
+ frame_rot=frame_rot,
+ frame_t=frame_t,
+ frame_mask=frame_mask,
+ cyclic_period=chain["cyclic_period"],
+ affinity_mask=affinity_mask,
+ )
+ token_data.append(token_astuple(token))
+
+ # Update atom_idx to token_idx
+ atom_to_token.update(
+ dict.fromkeys(range(atom_start, atom_end), token_idx)
+ )
+
+ token_idx += 1
+
+ # Non-standard are tokenized per atom
+ elif chain["mol_type"] == const.chain_type_ids["NONPOLYMER"]:
+ # We use the unk protein token as res_type
+ unk_token = const.unk_token["PROTEIN"]
+ unk_id = const.token_ids[unk_token]
+
+ # Get atom coordinates
+ atom_data = struct.atoms[atom_start:atom_end]
+ atom_coords = struct.coords[offset + atom_start : offset + atom_end][
+ "coords"
+ ]
+
+ # Tokenize each atom
+ for i, atom in enumerate(atom_data):
+ # Token is present if atom is
+ is_present = res["is_present"] & atom["is_present"]
+ index = atom_start + i
+
+ # Create token
+ token = TokenData(
+ token_idx=token_idx,
+ atom_idx=index,
+ atom_num=1,
+ res_idx=res["res_idx"],
+ res_type=unk_id,
+ res_name=res["name"],
+ sym_id=chain["sym_id"],
+ asym_id=chain["asym_id"],
+ entity_id=chain["entity_id"],
+ mol_type=chain["mol_type"],
+ center_idx=index,
+ disto_idx=index,
+ center_coords=atom_coords[i],
+ disto_coords=atom_coords[i],
+ resolved_mask=is_present,
+ disto_mask=is_present,
+ modified=chain["mol_type"]
+ != const.chain_type_ids["NONPOLYMER"],
+ frame_rot=np.eye(3).flatten(),
+ frame_t=np.zeros(3),
+ frame_mask=False,
+ cyclic_period=chain["cyclic_period"],
+ affinity_mask=affinity_mask,
+ )
+ token_data.append(token_astuple(token))
+
+ # Update atom_idx to token_idx
+ atom_to_token[index] = token_idx
+ token_idx += 1
+
+ # Modified residues in Boltz-2 are tokenized at residue level
+ else:
+ res_type = get_unk_token(chain)
+
+ # Get center and disto atoms
+ center = struct.atoms[res["atom_center"]]
+ disto = struct.atoms[res["atom_disto"]]
+
+ # Token is present if centers are
+ is_present = res["is_present"] & center["is_present"]
+ is_disto_present = res["is_present"] & disto["is_present"]
+
+ # Apply chain transformation
+ c_coords = struct.coords[offset + res["atom_center"]]["coords"]
+ d_coords = struct.coords[offset + res["atom_disto"]]["coords"]
+
+ # Create token
+ token = TokenData(
+ token_idx=token_idx,
+ atom_idx=res["atom_idx"],
+ atom_num=res["atom_num"],
+ res_idx=res["res_idx"],
+ res_type=res_type,
+ res_name=res["name"],
+ sym_id=chain["sym_id"],
+ asym_id=chain["asym_id"],
+ entity_id=chain["entity_id"],
+ mol_type=chain["mol_type"],
+ center_idx=res["atom_center"],
+ disto_idx=res["atom_disto"],
+ center_coords=c_coords,
+ disto_coords=d_coords,
+ resolved_mask=is_present,
+ disto_mask=is_disto_present,
+ modified=True,
+ frame_rot=np.eye(3).flatten(),
+ frame_t=np.zeros(3),
+ frame_mask=False,
+ cyclic_period=chain["cyclic_period"],
+ affinity_mask=affinity_mask,
+ )
+ token_data.append(token_astuple(token))
+
+ # Update atom_idx to token_idx
+ atom_to_token.update(
+ dict.fromkeys(range(atom_start, atom_end), token_idx)
+ )
+
+ token_idx += 1
+
+ # Create token bonds
+ token_bonds = []
+
+ # Add atom-atom bonds from ligands
+ for bond in struct.bonds:
+ if bond["atom_1"] not in atom_to_token or bond["atom_2"] not in atom_to_token:
+ continue
+ token_bond = (
+ atom_to_token[bond["atom_1"]],
+ atom_to_token[bond["atom_2"]],
+ bond["type"] + 1,
+ )
+ token_bonds.append(token_bond)
+
+ token_data = np.array(token_data, dtype=TokenV2)
+ token_bonds = np.array(token_bonds, dtype=TokenBondV2)
+
+ return token_data, token_bonds
+
+
+class Boltz2Tokenizer(Tokenizer):
+ """Tokenize an input structure for training."""
+
+ def tokenize(self, data: Input) -> Tokenized:
+ """Tokenize the input data.
+
+ Parameters
+ ----------
+ data : Input
+ The input data.
+
+ Returns
+ -------
+ Tokenized
+ The tokenized data.
+
+ """
+ # Tokenize the structure
+ token_data, token_bonds = tokenize_structure(
+ data.structure, data.record.affinity
+ )
+
+ # Tokenize the templates
+ if data.templates is not None:
+ template_tokens = {}
+ template_bonds = {}
+ for template_id, template in data.templates.items():
+ tmpl_token_data, tmpl_token_bonds = tokenize_structure(template)
+ template_tokens[template_id] = tmpl_token_data
+ template_bonds[template_id] = tmpl_token_bonds
+ else:
+ template_tokens = None
+ template_bonds = None
+
+ # Create the tokenized data
+ tokenized = Tokenized(
+ tokens=token_data,
+ bonds=token_bonds,
+ structure=data.structure,
+ msa=data.msa,
+ record=data.record,
+ residue_constraints=data.residue_constraints,
+ templates=data.templates,
+ template_tokens=template_tokens,
+ template_bonds=template_bonds,
+ extra_mols=data.extra_mols,
+ )
+ return tokenized
diff --git a/forks/boltz/src/boltz/data/tokenize/tokenizer.py b/forks/boltz/src/boltz/data/tokenize/tokenizer.py
new file mode 100644
index 00000000..dce81229
--- /dev/null
+++ b/forks/boltz/src/boltz/data/tokenize/tokenizer.py
@@ -0,0 +1,24 @@
+from abc import ABC, abstractmethod
+
+from boltz.data.types import Input, Tokenized
+
+
+class Tokenizer(ABC):
+ """Tokenize an input structure for training."""
+
+ @abstractmethod
+ def tokenize(self, data: Input) -> Tokenized:
+ """Tokenize the input data.
+
+ Parameters
+ ----------
+ data : Input
+ The input data.
+
+ Returns
+ -------
+ Tokenized
+ The tokenized data.
+
+ """
+ raise NotImplementedError
diff --git a/forks/boltz/src/boltz/data/types.py b/forks/boltz/src/boltz/data/types.py
new file mode 100644
index 00000000..1ce26b55
--- /dev/null
+++ b/forks/boltz/src/boltz/data/types.py
@@ -0,0 +1,784 @@
+import json
+from dataclasses import asdict, dataclass
+from pathlib import Path
+from typing import Optional, Union
+
+import numpy as np
+from mashumaro.mixins.dict import DataClassDictMixin
+from rdkit.Chem import Mol
+
+####################################################################################################
+# SERIALIZABLE
+####################################################################################################
+
+
+class NumpySerializable:
+ """Serializable datatype."""
+
+ @classmethod
+ def load(cls: "NumpySerializable", path: Path) -> "NumpySerializable":
+ """Load the object from an NPZ file.
+
+ Parameters
+ ----------
+ path : Path
+ The path to the file.
+
+ Returns
+ -------
+ Serializable
+ The loaded object.
+
+ """
+ return cls(**np.load(path, allow_pickle=True))
+
+ def dump(self, path: Path) -> None:
+ """Dump the object to an NPZ file.
+
+ Parameters
+ ----------
+ path : Path
+ The path to the file.
+
+ """
+ np.savez_compressed(str(path), **asdict(self))
+
+
+class JSONSerializable(DataClassDictMixin):
+ """Serializable datatype."""
+
+ @classmethod
+ def load(cls: "JSONSerializable", path: Path) -> "JSONSerializable":
+ """Load the object from a JSON file.
+
+ Parameters
+ ----------
+ path : Path
+ The path to the file.
+
+ Returns
+ -------
+ Serializable
+ The loaded object.
+
+ """
+ with path.open("r") as f:
+ return cls.from_dict(json.load(f))
+
+ def dump(self, path: Path) -> None:
+ """Dump the object to a JSON file.
+
+ Parameters
+ ----------
+ path : Path
+ The path to the file.
+
+ """
+ with path.open("w") as f:
+ json.dump(self.to_dict(), f)
+
+
+####################################################################################################
+# STRUCTURE
+####################################################################################################
+
+Atom = [
+ ("name", np.dtype("4i1")),
+ ("element", np.dtype("i1")),
+ ("charge", np.dtype("i1")),
+ ("coords", np.dtype("3f4")),
+ ("conformer", np.dtype("3f4")),
+ ("is_present", np.dtype("?")),
+ ("chirality", np.dtype("i1")),
+]
+
+AtomV2 = [
+ ("name", np.dtype(" "Structure":
+ """Load a structure from an NPZ file.
+
+ Parameters
+ ----------
+ path : Path
+ The path to the file.
+
+ Returns
+ -------
+ Structure
+ The loaded structure.
+
+ """
+ structure = np.load(path)
+ return cls(
+ atoms=structure["atoms"],
+ bonds=structure["bonds"],
+ residues=structure["residues"],
+ chains=structure["chains"],
+ connections=structure["connections"].astype(Connection),
+ interfaces=structure["interfaces"],
+ mask=structure["mask"],
+ )
+
+ def remove_invalid_chains(self) -> "Structure": # noqa: PLR0915
+ """Remove invalid chains.
+
+ Parameters
+ ----------
+ structure : Structure
+ The structure to process.
+
+ Returns
+ -------
+ Structure
+ The structure with masked chains removed.
+
+ """
+ entity_counter = {}
+ atom_idx, res_idx, chain_idx = 0, 0, 0
+ atoms, residues, chains = [], [], []
+ atom_map, res_map, chain_map = {}, {}, {}
+ for i, chain in enumerate(self.chains):
+ # Skip masked chains
+ if not self.mask[i]:
+ continue
+
+ # Update entity counter
+ entity_id = chain["entity_id"]
+ if entity_id not in entity_counter:
+ entity_counter[entity_id] = 0
+ else:
+ entity_counter[entity_id] += 1
+
+ # Update the chain
+ new_chain = chain.copy()
+ new_chain["atom_idx"] = atom_idx
+ new_chain["res_idx"] = res_idx
+ new_chain["asym_id"] = chain_idx
+ new_chain["sym_id"] = entity_counter[entity_id]
+ chains.append(new_chain)
+ chain_map[i] = chain_idx
+ chain_idx += 1
+
+ # Add the chain residues
+ res_start = chain["res_idx"]
+ res_end = chain["res_idx"] + chain["res_num"]
+ for j, res in enumerate(self.residues[res_start:res_end]):
+ # Update the residue
+ new_res = res.copy()
+ new_res["atom_idx"] = atom_idx
+ new_res["atom_center"] = (
+ atom_idx + new_res["atom_center"] - res["atom_idx"]
+ )
+ new_res["atom_disto"] = (
+ atom_idx + new_res["atom_disto"] - res["atom_idx"]
+ )
+ residues.append(new_res)
+ res_map[res_start + j] = res_idx
+ res_idx += 1
+
+ # Update the atoms
+ start = res["atom_idx"]
+ end = res["atom_idx"] + res["atom_num"]
+ atoms.append(self.atoms[start:end])
+ atom_map.update({k: atom_idx + k - start for k in range(start, end)})
+ atom_idx += res["atom_num"]
+
+ # Concatenate the tables
+ atoms = np.concatenate(atoms, dtype=Atom)
+ residues = np.array(residues, dtype=Residue)
+ chains = np.array(chains, dtype=Chain)
+
+ # Update bonds
+ bonds = []
+ for bond in self.bonds:
+ atom_1 = bond["atom_1"]
+ atom_2 = bond["atom_2"]
+ if (atom_1 in atom_map) and (atom_2 in atom_map):
+ new_bond = bond.copy()
+ new_bond["atom_1"] = atom_map[atom_1]
+ new_bond["atom_2"] = atom_map[atom_2]
+ bonds.append(new_bond)
+
+ # Update connections
+ connections = []
+ for connection in self.connections:
+ chain_1 = connection["chain_1"]
+ chain_2 = connection["chain_2"]
+ res_1 = connection["res_1"]
+ res_2 = connection["res_2"]
+ atom_1 = connection["atom_1"]
+ atom_2 = connection["atom_2"]
+ if (atom_1 in atom_map) and (atom_2 in atom_map):
+ new_connection = connection.copy()
+ new_connection["chain_1"] = chain_map[chain_1]
+ new_connection["chain_2"] = chain_map[chain_2]
+ new_connection["res_1"] = res_map[res_1]
+ new_connection["res_2"] = res_map[res_2]
+ new_connection["atom_1"] = atom_map[atom_1]
+ new_connection["atom_2"] = atom_map[atom_2]
+ connections.append(new_connection)
+
+ # Create arrays
+ bonds = np.array(bonds, dtype=Bond)
+ connections = np.array(connections, dtype=Connection)
+ interfaces = np.array([], dtype=Interface)
+ mask = np.ones(len(chains), dtype=bool)
+
+ return Structure(
+ atoms=atoms,
+ bonds=bonds,
+ residues=residues,
+ chains=chains,
+ connections=connections,
+ interfaces=interfaces,
+ mask=mask,
+ )
+
+
+@dataclass(frozen=True)
+class StructureV2(NumpySerializable):
+ """Structure datatype."""
+
+ atoms: np.ndarray
+ bonds: np.ndarray
+ residues: np.ndarray
+ chains: np.ndarray
+ interfaces: np.ndarray
+ mask: np.ndarray
+ coords: np.ndarray
+ ensemble: np.ndarray
+ pocket: Optional[np.ndarray] = None
+
+ def remove_invalid_chains(self) -> "StructureV2": # noqa: PLR0915
+ """Remove invalid chains.
+
+ Parameters
+ ----------
+ structure : Structure
+ The structure to process.
+
+ Returns
+ -------
+ Structure
+ The structure with masked chains removed.
+
+ """
+ entity_counter = {}
+ atom_idx, res_idx, chain_idx = 0, 0, 0
+ atoms, residues, chains = [], [], []
+ atom_map, res_map, chain_map = {}, {}, {}
+ for i, chain in enumerate(self.chains):
+ # Skip masked chains
+ if not self.mask[i]:
+ continue
+
+ # Update entity counter
+ entity_id = chain["entity_id"]
+ if entity_id not in entity_counter:
+ entity_counter[entity_id] = 0
+ else:
+ entity_counter[entity_id] += 1
+
+ # Update the chain
+ new_chain = chain.copy()
+ new_chain["atom_idx"] = atom_idx
+ new_chain["res_idx"] = res_idx
+ new_chain["asym_id"] = chain_idx
+ new_chain["sym_id"] = entity_counter[entity_id]
+ chains.append(new_chain)
+ chain_map[i] = chain_idx
+ chain_idx += 1
+
+ # Add the chain residues
+ res_start = chain["res_idx"]
+ res_end = chain["res_idx"] + chain["res_num"]
+ for j, res in enumerate(self.residues[res_start:res_end]):
+ # Update the residue
+ new_res = res.copy()
+ new_res["atom_idx"] = atom_idx
+ new_res["atom_center"] = (
+ atom_idx + new_res["atom_center"] - res["atom_idx"]
+ )
+ new_res["atom_disto"] = (
+ atom_idx + new_res["atom_disto"] - res["atom_idx"]
+ )
+ residues.append(new_res)
+ res_map[res_start + j] = res_idx
+ res_idx += 1
+
+ # Update the atoms
+ start = res["atom_idx"]
+ end = res["atom_idx"] + res["atom_num"]
+ atoms.append(self.atoms[start:end])
+ atom_map.update({k: atom_idx + k - start for k in range(start, end)})
+ atom_idx += res["atom_num"]
+
+ # Concatenate the tables
+ atoms = np.concatenate(atoms, dtype=AtomV2)
+ residues = np.array(residues, dtype=Residue)
+ chains = np.array(chains, dtype=Chain)
+
+ # Update bonds
+ bonds = []
+ for bond in self.bonds:
+ chain_1 = bond["chain_1"]
+ chain_2 = bond["chain_2"]
+ res_1 = bond["res_1"]
+ res_2 = bond["res_2"]
+ atom_1 = bond["atom_1"]
+ atom_2 = bond["atom_2"]
+ if (atom_1 in atom_map) and (atom_2 in atom_map):
+ new_bond = bond.copy()
+ new_bond["chain_1"] = chain_map[chain_1]
+ new_bond["chain_2"] = chain_map[chain_2]
+ new_bond["res_1"] = res_map[res_1]
+ new_bond["res_2"] = res_map[res_2]
+ new_bond["atom_1"] = atom_map[atom_1]
+ new_bond["atom_2"] = atom_map[atom_2]
+ bonds.append(new_bond)
+
+ # Create arrays
+ bonds = np.array(bonds, dtype=BondV2)
+ interfaces = np.array([], dtype=Interface)
+ mask = np.ones(len(chains), dtype=bool)
+ coords = [(x,) for x in atoms["coords"]]
+ coords = np.array(coords, dtype=Coords)
+ ensemble = np.array([(0, len(coords))], dtype=Ensemble)
+
+ return StructureV2(
+ atoms=atoms,
+ bonds=bonds,
+ residues=residues,
+ chains=chains,
+ interfaces=interfaces,
+ mask=mask,
+ coords=coords,
+ ensemble=ensemble,
+ )
+
+
+####################################################################################################
+# MSA
+####################################################################################################
+
+
+MSAResidue = [
+ ("res_type", np.dtype("i1")),
+]
+
+MSADeletion = [
+ ("res_idx", np.dtype("i2")),
+ ("deletion", np.dtype("i2")),
+]
+
+MSASequence = [
+ ("seq_idx", np.dtype("i2")),
+ ("taxonomy", np.dtype("i4")),
+ ("res_start", np.dtype("i4")),
+ ("res_end", np.dtype("i4")),
+ ("del_start", np.dtype("i4")),
+ ("del_end", np.dtype("i4")),
+]
+
+
+@dataclass(frozen=True)
+class MSA(NumpySerializable):
+ """MSA datatype."""
+
+ sequences: np.ndarray
+ deletions: np.ndarray
+ residues: np.ndarray
+
+
+####################################################################################################
+# RECORD
+####################################################################################################
+
+
+@dataclass(frozen=True)
+class StructureInfo:
+ """StructureInfo datatype."""
+
+ resolution: Optional[float] = None
+ method: Optional[str] = None
+ deposited: Optional[str] = None
+ released: Optional[str] = None
+ revised: Optional[str] = None
+ num_chains: Optional[int] = None
+ num_interfaces: Optional[int] = None
+ pH: Optional[float] = None
+ temperature: Optional[float] = None
+
+
+@dataclass(frozen=False)
+class ChainInfo:
+ """ChainInfo datatype."""
+
+ chain_id: int
+ chain_name: str
+ mol_type: int
+ cluster_id: Union[str, int]
+ msa_id: Union[str, int]
+ num_residues: int
+ valid: bool = True
+ entity_id: Optional[Union[str, int]] = None
+
+
+@dataclass(frozen=True)
+class InterfaceInfo:
+ """InterfaceInfo datatype."""
+
+ chain_1: int
+ chain_2: int
+ valid: bool = True
+
+
+@dataclass(frozen=True)
+class InferenceOptions:
+ """InferenceOptions datatype."""
+
+ pocket_constraints: Optional[
+ list[tuple[int, list[tuple[int, int]], float, bool]]
+ ] = None
+ contact_constraints: Optional[
+ list[tuple[tuple[int, int], tuple[int, int], float, bool]]
+ ] = None
+
+
+@dataclass(frozen=True)
+class MDInfo:
+ """MDInfo datatype."""
+
+ forcefield: Optional[list[str]]
+ temperature: Optional[float] # Kelvin
+ pH: Optional[float]
+ pressure: Optional[float] # bar
+ prod_ensemble: Optional[str]
+ solvent: Optional[str]
+ ion_concentration: Optional[float] # mM
+ time_step: Optional[float] # fs
+ sample_frame_time: Optional[float] # ps
+ sim_time: Optional[float] # ns
+ coarse_grained: Optional[bool] = False
+
+
+@dataclass(frozen=True)
+class TemplateInfo:
+ """InterfaceInfo datatype."""
+
+ name: str
+ query_chain: str
+ query_st: int
+ query_en: int
+ template_chain: str
+ template_st: int
+ template_en: int
+ force: bool = False
+ threshold: Optional[float] = float("inf")
+
+
+@dataclass(frozen=True)
+class AffinityInfo:
+ """AffinityInfo datatype."""
+
+ chain_id: int
+ mw: float
+
+
+@dataclass(frozen=True)
+class Record(JSONSerializable):
+ """Record datatype."""
+
+ id: str
+ structure: StructureInfo
+ chains: list[ChainInfo]
+ interfaces: list[InterfaceInfo]
+ inference_options: Optional[InferenceOptions] = None
+ templates: Optional[list[TemplateInfo]] = None
+ md: Optional[MDInfo] = None
+ affinity: Optional[AffinityInfo] = None
+
+
+####################################################################################################
+# RESIDUE CONSTRAINTS
+####################################################################################################
+
+
+RDKitBoundsConstraint = [
+ ("atom_idxs", np.dtype("2i4")),
+ ("is_bond", np.dtype("?")),
+ ("is_angle", np.dtype("?")),
+ ("upper_bound", np.dtype("f4")),
+ ("lower_bound", np.dtype("f4")),
+]
+
+ChiralAtomConstraint = [
+ ("atom_idxs", np.dtype("4i4")),
+ ("is_reference", np.dtype("?")),
+ ("is_r", np.dtype("?")),
+]
+
+StereoBondConstraint = [
+ ("atom_idxs", np.dtype("4i4")),
+ ("is_reference", np.dtype("?")),
+ ("is_e", np.dtype("?")),
+]
+
+PlanarBondConstraint = [
+ ("atom_idxs", np.dtype("6i4")),
+]
+
+PlanarRing5Constraint = [
+ ("atom_idxs", np.dtype("5i4")),
+]
+
+PlanarRing6Constraint = [
+ ("atom_idxs", np.dtype("6i4")),
+]
+
+
+@dataclass(frozen=True)
+class ResidueConstraints(NumpySerializable):
+ """ResidueConstraints datatype."""
+
+ rdkit_bounds_constraints: np.ndarray
+ chiral_atom_constraints: np.ndarray
+ stereo_bond_constraints: np.ndarray
+ planar_bond_constraints: np.ndarray
+ planar_ring_5_constraints: np.ndarray
+ planar_ring_6_constraints: np.ndarray
+
+
+####################################################################################################
+# TARGET
+####################################################################################################
+
+
+@dataclass(frozen=True)
+class Target:
+ """Target datatype."""
+
+ record: Record
+ structure: Structure
+ sequences: Optional[dict[str, str]] = None
+ residue_constraints: Optional[ResidueConstraints] = None
+ templates: Optional[dict[str, StructureV2]] = None
+ extra_mols: Optional[dict[str, Mol]] = None
+
+
+@dataclass(frozen=True)
+class Manifest(JSONSerializable):
+ """Manifest datatype."""
+
+ records: list[Record]
+
+ @classmethod
+ def load(cls: "JSONSerializable", path: Path) -> "JSONSerializable":
+ """Load the object from a JSON file.
+
+ Parameters
+ ----------
+ path : Path
+ The path to the file.
+
+ Returns
+ -------
+ Serializable
+ The loaded object.
+
+ Raises
+ ------
+ TypeError
+ If the file is not a valid manifest file.
+
+ """
+ with path.open("r") as f:
+ data = json.load(f)
+ if isinstance(data, dict):
+ manifest = cls.from_dict(data)
+ elif isinstance(data, list):
+ records = [Record.from_dict(r) for r in data]
+ manifest = cls(records=records)
+ else:
+ msg = "Invalid manifest file."
+ raise TypeError(msg)
+
+ return manifest
+
+
+####################################################################################################
+# INPUT
+####################################################################################################
+
+
+@dataclass(frozen=True, slots=True)
+class Input:
+ """Input datatype."""
+
+ structure: Structure
+ msa: dict[str, MSA]
+ record: Optional[Record] = None
+ residue_constraints: Optional[ResidueConstraints] = None
+ templates: Optional[dict[str, StructureV2]] = None
+ extra_mols: Optional[dict[str, Mol]] = None
+
+
+####################################################################################################
+# TOKENS
+####################################################################################################
+
+Token = [
+ ("token_idx", np.dtype("i4")),
+ ("atom_idx", np.dtype("i4")),
+ ("atom_num", np.dtype("i4")),
+ ("res_idx", np.dtype("i4")),
+ ("res_type", np.dtype("i1")),
+ ("sym_id", np.dtype("i4")),
+ ("asym_id", np.dtype("i4")),
+ ("entity_id", np.dtype("i4")),
+ ("mol_type", np.dtype("i1")),
+ ("center_idx", np.dtype("i4")),
+ ("disto_idx", np.dtype("i4")),
+ ("center_coords", np.dtype("3f4")),
+ ("disto_coords", np.dtype("3f4")),
+ ("resolved_mask", np.dtype("?")),
+ ("disto_mask", np.dtype("?")),
+ ("cyclic_period", np.dtype("i4")),
+]
+
+TokenBond = [
+ ("token_1", np.dtype("i4")),
+ ("token_2", np.dtype("i4")),
+]
+
+
+TokenV2 = [
+ ("token_idx", np.dtype("i4")),
+ ("atom_idx", np.dtype("i4")),
+ ("atom_num", np.dtype("i4")),
+ ("res_idx", np.dtype("i4")),
+ ("res_type", np.dtype("i4")),
+ ("res_name", np.dtype(" str: # noqa: C901, PLR0915, PLR0912
+ """Write a structure into an MMCIF file.
+
+ Parameters
+ ----------
+ structure : Structure
+ The input structure
+
+ Returns
+ -------
+ str
+ the output MMCIF file
+
+ """
+ system = System()
+
+ # Load periodic table for element mapping
+ periodic_table = Chem.GetPeriodicTable()
+
+ # Map entities to chain_ids
+ entity_to_chains = {}
+ entity_to_moltype = {}
+
+ for chain in structure.chains:
+ entity_id = chain["entity_id"]
+ mol_type = chain["mol_type"]
+ entity_to_chains.setdefault(entity_id, []).append(chain)
+ entity_to_moltype[entity_id] = mol_type
+
+ # Map entities to sequences
+ sequences = {}
+ for entity in entity_to_chains:
+ # Get the first chain
+ chain = entity_to_chains[entity][0]
+
+ # Get the sequence
+ res_start = chain["res_idx"]
+ res_end = chain["res_idx"] + chain["res_num"]
+ residues = structure.residues[res_start:res_end]
+ sequence = [str(res["name"]) for res in residues]
+ sequences[entity] = sequence
+
+ # Create entity objects
+ lig_entity = None
+ entities_map = {}
+ for entity, sequence in sequences.items():
+ mol_type = entity_to_moltype[entity]
+
+ if mol_type == const.chain_type_ids["PROTEIN"]:
+ alphabet = ihm.LPeptideAlphabet()
+ chem_comp = lambda x: ihm.LPeptideChemComp(id=x, code=x, code_canonical="X") # noqa: E731
+ elif mol_type == const.chain_type_ids["DNA"]:
+ alphabet = ihm.DNAAlphabet()
+ chem_comp = lambda x: ihm.DNAChemComp(id=x, code=x, code_canonical="N") # noqa: E731
+ elif mol_type == const.chain_type_ids["RNA"]:
+ alphabet = ihm.RNAAlphabet()
+ chem_comp = lambda x: ihm.RNAChemComp(id=x, code=x, code_canonical="N") # noqa: E731
+ elif len(sequence) > 1:
+ alphabet = {}
+ chem_comp = lambda x: ihm.SaccharideChemComp(id=x) # noqa: E731
+ else:
+ alphabet = {}
+ chem_comp = lambda x: ihm.NonPolymerChemComp(id=x) # noqa: E731
+
+ # Handle smiles
+ if len(sequence) == 1 and (sequence[0] == "LIG"):
+ if lig_entity is None:
+ seq = [chem_comp(sequence[0])]
+ lig_entity = Entity(seq)
+ model_e = lig_entity
+ else:
+ seq = [
+ alphabet[item] if item in alphabet else chem_comp(item)
+ for item in sequence
+ ]
+ model_e = Entity(seq)
+
+ for chain in entity_to_chains[entity]:
+ chain_idx = chain["asym_id"]
+ entities_map[chain_idx] = model_e
+
+ # We don't assume that symmetry is perfect, so we dump everything
+ # into the asymmetric unit, and produce just a single assembly
+ asym_unit_map = {}
+ for chain in structure.chains:
+ # Define the model assembly
+ chain_idx = chain["asym_id"]
+ chain_tag = str(chain["name"])
+ entity = entities_map[chain_idx]
+ if entity.type == "water":
+ asym = ihm.WaterAsymUnit(
+ entity,
+ 1,
+ details="Model subunit %s" % chain_tag,
+ id=chain_tag,
+ )
+ else:
+ asym = AsymUnit(
+ entity,
+ details="Model subunit %s" % chain_tag,
+ id=chain_tag,
+ )
+ asym_unit_map[chain_idx] = asym
+ modeled_assembly = Assembly(asym_unit_map.values(), name="Modeled assembly")
+
+ class _LocalPLDDT(modelcif.qa_metric.Local, modelcif.qa_metric.PLDDT):
+ name = "pLDDT"
+ software = None
+ description = "Predicted lddt"
+
+ class _MyModel(AbInitioModel):
+ def get_atoms(self) -> Iterator[Atom]:
+ # Index into plddt tensor for current residue.
+ res_num = 0
+ # Tracks non-ligand plddt tensor indices,
+ # Initializing to -1 handles case where ligand is resnum 0
+ prev_polymer_resnum = -1
+ # Tracks ligand indices.
+ ligand_index_offset = 0
+
+ # Add all atom sites.
+ for chain in structure.chains:
+ # We rename the chains in alphabetical order
+ het = chain["mol_type"] == const.chain_type_ids["NONPOLYMER"]
+ chain_idx = chain["asym_id"]
+ res_start = chain["res_idx"]
+ res_end = chain["res_idx"] + chain["res_num"]
+
+ record_type = (
+ "ATOM"
+ if chain["mol_type"] != const.chain_type_ids["NONPOLYMER"]
+ else "HETATM"
+ )
+
+ residues = structure.residues[res_start:res_end]
+ for residue in residues:
+ res_name = str(residue["name"])
+ atom_start = residue["atom_idx"]
+ atom_end = residue["atom_idx"] + residue["atom_num"]
+ atoms = structure.atoms[atom_start:atom_end]
+ atom_coords = atoms["coords"]
+ for i, atom in enumerate(atoms):
+ # This should not happen on predictions, but just in case.
+ if not atom["is_present"]:
+ continue
+
+ if boltz2:
+ atom_name = str(atom["name"])
+ atom_key = re.sub(r"\d", "", atom_name)
+ if atom_key in const.ambiguous_atoms:
+ if isinstance(const.ambiguous_atoms[atom_key], str):
+ element = const.ambiguous_atoms[atom_key]
+ elif res_name in const.ambiguous_atoms[atom_key]:
+ element = const.ambiguous_atoms[atom_key][res_name]
+ else:
+ element = const.ambiguous_atoms[atom_key]["*"]
+ else:
+ element = atom_key[0]
+ else:
+ atom_name = atom["name"]
+ atom_name = [chr(c + 32) for c in atom_name if c != 0]
+ atom_name = "".join(atom_name)
+ element = periodic_table.GetElementSymbol(
+ atom["element"].item()
+ )
+ element = element.upper()
+ residue_index = residue["res_idx"] + 1
+ pos = atom_coords[i]
+
+ if record_type != "HETATM":
+ # The current residue plddt is stored at the res_num index unless a ligand has previouly been added.
+ biso = (
+ 100.00
+ if plddts is None
+ else round(
+ plddts[res_num + ligand_index_offset].item() * 100,
+ 3,
+ )
+ )
+ prev_polymer_resnum = res_num
+ else:
+ # If not a polymer resnum, we can get index into plddts by adding offset relative to previous polymer resnum.
+ ligand_index_offset += 1
+ biso = (
+ 100.00
+ if plddts is None
+ else round(
+ plddts[
+ prev_polymer_resnum + ligand_index_offset
+ ].item()
+ * 100,
+ 3,
+ )
+ )
+
+ yield Atom(
+ asym_unit=asym_unit_map[chain_idx],
+ type_symbol=element,
+ seq_id=residue_index,
+ atom_id=atom_name,
+ x=f"{pos[0]:.5f}",
+ y=f"{pos[1]:.5f}",
+ z=f"{pos[2]:.5f}",
+ het=het,
+ biso=biso,
+ occupancy=1,
+ )
+
+ if record_type != "HETATM":
+ res_num += 1
+
+ def add_plddt(self, plddts):
+ res_num = 0
+ prev_polymer_resnum = (
+ -1
+ ) # -1 handles case where ligand is the first residue
+ ligand_index_offset = 0
+ for chain in structure.chains:
+ chain_idx = chain["asym_id"]
+ res_start = chain["res_idx"]
+ res_end = chain["res_idx"] + chain["res_num"]
+ residues = structure.residues[res_start:res_end]
+
+ record_type = (
+ "ATOM"
+ if chain["mol_type"] != const.chain_type_ids["NONPOLYMER"]
+ else "HETATM"
+ )
+
+ # We rename the chains in alphabetical order
+ for residue in residues:
+ residue_idx = residue["res_idx"] + 1
+
+ atom_start = residue["atom_idx"]
+ atom_end = residue["atom_idx"] + residue["atom_num"]
+
+ if record_type != "HETATM":
+ # The current residue plddt is stored at the res_num index unless a ligand has previouly been added.
+ self.qa_metrics.append(
+ _LocalPLDDT(
+ asym_unit_map[chain_idx].residue(residue_idx),
+ round(
+ plddts[res_num + ligand_index_offset].item() * 100,
+ 3,
+ ),
+ )
+ )
+ prev_polymer_resnum = res_num
+ else:
+ # If not a polymer resnum, we can get index into plddts by adding offset relative to previous polymer resnum.
+ self.qa_metrics.append(
+ _LocalPLDDT(
+ asym_unit_map[chain_idx].residue(residue_idx),
+ round(
+ plddts[
+ prev_polymer_resnum
+ + ligand_index_offset
+ + 1 : prev_polymer_resnum
+ + ligand_index_offset
+ + residue["atom_num"]
+ + 1
+ ]
+ .mean()
+ .item()
+ * 100,
+ 2,
+ ),
+ )
+ )
+ ligand_index_offset += residue["atom_num"]
+
+ if record_type != "HETATM":
+ res_num += 1
+
+ # Add the model and modeling protocol to the file and write them out:
+ model = _MyModel(assembly=modeled_assembly, name="Model")
+ if plddts is not None:
+ model.add_plddt(plddts)
+
+ model_group = ModelGroup([model], name="All models")
+ system.model_groups.append(model_group)
+ ihm.dumper.set_line_wrap(False)
+
+ fh = io.StringIO()
+ dumper.write(fh, [system])
+ return fh.getvalue()
diff --git a/forks/boltz/src/boltz/data/write/pdb.py b/forks/boltz/src/boltz/data/write/pdb.py
new file mode 100644
index 00000000..d9240adc
--- /dev/null
+++ b/forks/boltz/src/boltz/data/write/pdb.py
@@ -0,0 +1,172 @@
+import re
+from typing import Optional
+
+from rdkit import Chem
+from torch import Tensor
+
+from boltz.data import const
+from boltz.data.types import Structure
+
+
+def to_pdb(
+ structure: Structure,
+ plddts: Optional[Tensor] = None,
+ boltz2: bool = False,
+) -> str: # noqa: PLR0915
+ """Write a structure into a PDB file.
+
+ Parameters
+ ----------
+ structure : Structure
+ The input structure
+
+ Returns
+ -------
+ str
+ the output PDB file
+
+ """
+ pdb_lines = []
+
+ atom_index = 1
+ atom_reindex_ter = []
+
+ # Load periodic table for element mapping
+ periodic_table = Chem.GetPeriodicTable()
+
+ # Index into plddt tensor for current residue.
+ res_num = 0
+ # Tracks non-ligand plddt tensor indices,
+ # Initializing to -1 handles case where ligand is resnum 0
+ prev_polymer_resnum = -1
+ # Tracks ligand indices.
+ ligand_index_offset = 0
+
+ # Add all atom sites.
+ for chain in structure.chains:
+ # We rename the chains in alphabetical order
+ chain_idx = chain["asym_id"]
+ chain_tag = chain["name"]
+
+ res_start = chain["res_idx"]
+ res_end = chain["res_idx"] + chain["res_num"]
+
+ residues = structure.residues[res_start:res_end]
+ for residue in residues:
+ res_name = str(residue["name"])
+ atom_start = residue["atom_idx"]
+ atom_end = residue["atom_idx"] + residue["atom_num"]
+ atoms = structure.atoms[atom_start:atom_end]
+ atom_coords = atoms["coords"]
+ for i, atom in enumerate(atoms):
+ # This should not happen on predictions, but just in case.
+ if not atom["is_present"]:
+ continue
+
+ record_type = (
+ "ATOM"
+ if chain["mol_type"] != const.chain_type_ids["NONPOLYMER"]
+ else "HETATM"
+ )
+ name = str(atom["name"])
+ if boltz2:
+ atom_name = str(atom["name"])
+ atom_key = re.sub(r"\d", "", atom_name)
+ if atom_key in const.ambiguous_atoms:
+ if isinstance(const.ambiguous_atoms[atom_key], str):
+ element = const.ambiguous_atoms[atom_key]
+ elif res_name in const.ambiguous_atoms[atom_key]:
+ element = const.ambiguous_atoms[atom_key][res_name]
+ else:
+ element = const.ambiguous_atoms[atom_key]["*"]
+ else:
+ element = atom_key[0]
+ else:
+ atom_name = atom["name"]
+ atom_name = [chr(c + 32) for c in atom_name if c != 0]
+ atom_name = "".join(atom_name)
+ name = atom_name
+ element = periodic_table.GetElementSymbol(atom["element"].item())
+
+ name = name if len(name) == 4 else f" {name}" # noqa: PLR2004
+ alt_loc = ""
+ insertion_code = ""
+ occupancy = 1.00
+ element = element.upper()
+ charge = ""
+ residue_index = residue["res_idx"] + 1
+ pos = atom_coords[i]
+ res_name_3 = (
+ "LIG" if record_type == "HETATM" else str(residue["name"][:3])
+ )
+
+ if record_type != "HETATM":
+ # The current residue plddt is stored at the res_num index unless a ligand has previouly been added.
+ b_factor = (
+ 100.00
+ if plddts is None
+ else round(
+ plddts[res_num + ligand_index_offset].item() * 100, 2
+ )
+ )
+ prev_polymer_resnum = res_num
+ else:
+ # If not a polymer resnum, we can get index into plddts by adding offset relative to previous polymer resnum.
+ ligand_index_offset += 1
+ b_factor = (
+ 100.00
+ if plddts is None
+ else round(
+ plddts[prev_polymer_resnum + ligand_index_offset].item()
+ * 100,
+ 2,
+ )
+ )
+
+ # PDB is a columnar format, every space matters here!
+ atom_line = (
+ f"{record_type:<6}{atom_index:>5} {name:<4}{alt_loc:>1}"
+ f"{res_name_3:>3} {chain_tag:>1}"
+ f"{residue_index:>4}{insertion_code:>1} "
+ f"{pos[0]:>8.3f}{pos[1]:>8.3f}{pos[2]:>8.3f}"
+ f"{occupancy:>6.2f}{b_factor:>6.2f} "
+ f"{element:>2}{charge:>2}"
+ )
+ pdb_lines.append(atom_line)
+ atom_reindex_ter.append(atom_index)
+ atom_index += 1
+
+ if record_type != "HETATM":
+ res_num += 1
+
+ should_terminate = chain_idx < (len(structure.chains) - 1)
+ if should_terminate:
+ # Close the chain.
+ chain_end = "TER"
+ chain_termination_line = (
+ f"{chain_end:<6}{atom_index:>5} "
+ f"{res_name_3:>3} "
+ f"{chain_tag:>1}{residue_index:>4}"
+ )
+ pdb_lines.append(chain_termination_line)
+ atom_index += 1
+
+ # Dump CONECT records.
+ all_bonds = list(structure.bonds)
+ if hasattr(structure, "connections"):
+ all_bonds.extend(list(structure.connections))
+
+ for bond in all_bonds:
+ atom1 = structure.atoms[bond["atom_1"]]
+ atom2 = structure.atoms[bond["atom_2"]]
+ if not atom1["is_present"] or not atom2["is_present"]:
+ continue
+ atom1_idx = atom_reindex_ter[bond["atom_1"]]
+ atom2_idx = atom_reindex_ter[bond["atom_2"]]
+ conect_line = f"CONECT{atom1_idx:>5}{atom2_idx:>5}"
+ pdb_lines.append(conect_line)
+
+ pdb_lines.append("END")
+ pdb_lines.append("")
+ pdb_lines = [line.ljust(80) for line in pdb_lines]
+ return "\n".join(pdb_lines)
diff --git a/forks/boltz/src/boltz/data/write/utils.py b/forks/boltz/src/boltz/data/write/utils.py
new file mode 100644
index 00000000..617d8710
--- /dev/null
+++ b/forks/boltz/src/boltz/data/write/utils.py
@@ -0,0 +1,23 @@
+import string
+from collections.abc import Iterator
+
+
+def generate_tags() -> Iterator[str]:
+ """Generate chain tags.
+
+ Yields
+ ------
+ str
+ The next chain tag
+
+ """
+ for i in range(1, 4):
+ for j in range(len(string.ascii_uppercase) ** i):
+ tag = ""
+ for k in range(i):
+ tag += string.ascii_uppercase[
+ j
+ // (len(string.ascii_uppercase) ** k)
+ % len(string.ascii_uppercase)
+ ]
+ yield tag
diff --git a/forks/boltz/src/boltz/data/write/writer.py b/forks/boltz/src/boltz/data/write/writer.py
new file mode 100644
index 00000000..984be2ae
--- /dev/null
+++ b/forks/boltz/src/boltz/data/write/writer.py
@@ -0,0 +1,343 @@
+import json
+from dataclasses import asdict, replace
+from pathlib import Path
+from typing import Literal
+
+import numpy as np
+import torch
+from pytorch_lightning import LightningModule, Trainer
+from pytorch_lightning.callbacks import BasePredictionWriter
+from torch import Tensor
+
+from boltz.data.types import Coords, Interface, Record, Structure, StructureV2
+from boltz.data.write.mmcif import to_mmcif
+from boltz.data.write.pdb import to_pdb
+
+
+class BoltzWriter(BasePredictionWriter):
+ """Custom writer for predictions."""
+
+ def __init__(
+ self,
+ data_dir: str,
+ output_dir: str,
+ output_format: Literal["pdb", "mmcif"] = "mmcif",
+ boltz2: bool = False,
+ write_embeddings: bool = False,
+ ) -> None:
+ """Initialize the writer.
+
+ Parameters
+ ----------
+ output_dir : str
+ The directory to save the predictions.
+
+ """
+ super().__init__(write_interval="batch")
+ if output_format not in ["pdb", "mmcif"]:
+ msg = f"Invalid output format: {output_format}"
+ raise ValueError(msg)
+
+ self.data_dir = Path(data_dir)
+ self.output_dir = Path(output_dir)
+ self.output_format = output_format
+ self.failed = 0
+ self.boltz2 = boltz2
+ self.output_dir.mkdir(parents=True, exist_ok=True)
+ self.write_embeddings = write_embeddings
+
+ def write_on_batch_end(
+ self,
+ trainer: Trainer, # noqa: ARG002
+ pl_module: LightningModule, # noqa: ARG002
+ prediction: dict[str, Tensor],
+ batch_indices: list[int], # noqa: ARG002
+ batch: dict[str, Tensor],
+ batch_idx: int, # noqa: ARG002
+ dataloader_idx: int, # noqa: ARG002
+ ) -> None:
+ """Write the predictions to disk."""
+ if prediction["exception"]:
+ self.failed += 1
+ return
+
+ # Get the records
+ records: list[Record] = batch["record"]
+
+ # Get the predictions
+ coords = prediction["coords"]
+ coords = coords.unsqueeze(0)
+
+ pad_masks = prediction["masks"]
+
+ # Get ranking
+ if "confidence_score" in prediction:
+ argsort = torch.argsort(prediction["confidence_score"], descending=True)
+ idx_to_rank = {idx.item(): rank for rank, idx in enumerate(argsort)}
+ # Handles cases where confidence summary is False
+ else:
+ idx_to_rank = {i: i for i in range(len(records))}
+
+ # Iterate over the records
+ for record, coord, pad_mask in zip(records, coords, pad_masks):
+ # Load the structure
+ path = self.data_dir / f"{record.id}.npz"
+ if self.boltz2:
+ structure: StructureV2 = StructureV2.load(path)
+ else:
+ structure: Structure = Structure.load(path)
+
+ # Compute chain map with masked removed, to be used later
+ chain_map = {}
+ for i, mask in enumerate(structure.mask):
+ if mask:
+ chain_map[len(chain_map)] = i
+
+ # Remove masked chains completely
+ structure = structure.remove_invalid_chains()
+
+ for model_idx in range(coord.shape[0]):
+ # Get model coord
+ model_coord = coord[model_idx]
+ # Unpad
+ coord_unpad = model_coord[pad_mask.bool()]
+ coord_unpad = coord_unpad.cpu().numpy()
+
+ # New atom table
+ atoms = structure.atoms
+ atoms["coords"] = coord_unpad
+ atoms["is_present"] = True
+ if self.boltz2:
+ structure: StructureV2
+ coord_unpad = [(x,) for x in coord_unpad]
+ coord_unpad = np.array(coord_unpad, dtype=Coords)
+
+ # Mew residue table
+ residues = structure.residues
+ residues["is_present"] = True
+
+ # Update the structure
+ interfaces = np.array([], dtype=Interface)
+ if self.boltz2:
+ new_structure: StructureV2 = replace(
+ structure,
+ atoms=atoms,
+ residues=residues,
+ interfaces=interfaces,
+ coords=coord_unpad,
+ )
+ else:
+ new_structure: Structure = replace(
+ structure,
+ atoms=atoms,
+ residues=residues,
+ interfaces=interfaces,
+ )
+
+ # Update chain info
+ chain_info = []
+ for chain in new_structure.chains:
+ old_chain_idx = chain_map[chain["asym_id"]]
+ old_chain_info = record.chains[old_chain_idx]
+ new_chain_info = replace(
+ old_chain_info,
+ chain_id=int(chain["asym_id"]),
+ valid=True,
+ )
+ chain_info.append(new_chain_info)
+
+ # Save the structure
+ struct_dir = self.output_dir / record.id
+ struct_dir.mkdir(exist_ok=True)
+
+ # Get plddt's
+ plddts = None
+ if "plddt" in prediction:
+ plddts = prediction["plddt"][model_idx]
+
+ # Create path name
+ outname = f"{record.id}_model_{idx_to_rank[model_idx]}"
+
+ # Save the structure
+ if self.output_format == "pdb":
+ path = struct_dir / f"{outname}.pdb"
+ with path.open("w") as f:
+ f.write(
+ to_pdb(new_structure, plddts=plddts, boltz2=self.boltz2)
+ )
+ elif self.output_format == "mmcif":
+ path = struct_dir / f"{outname}.cif"
+ with path.open("w") as f:
+ f.write(
+ to_mmcif(new_structure, plddts=plddts, boltz2=self.boltz2)
+ )
+ else:
+ path = struct_dir / f"{outname}.npz"
+ np.savez_compressed(path, **asdict(new_structure))
+
+ if self.boltz2 and record.affinity and idx_to_rank[model_idx] == 0:
+ path = struct_dir / f"pre_affinity_{record.id}.npz"
+ np.savez_compressed(path, **asdict(new_structure))
+ np.array(atoms["coords"][:, None], dtype=Coords)
+
+ # Save confidence summary
+ if "plddt" in prediction:
+ path = (
+ struct_dir
+ / f"confidence_{record.id}_model_{idx_to_rank[model_idx]}.json"
+ )
+ confidence_summary_dict = {}
+ for key in [
+ "confidence_score",
+ "ptm",
+ "iptm",
+ "ligand_iptm",
+ "protein_iptm",
+ "complex_plddt",
+ "complex_iplddt",
+ "complex_pde",
+ "complex_ipde",
+ ]:
+ confidence_summary_dict[key] = prediction[key][model_idx].item()
+ confidence_summary_dict["chains_ptm"] = {
+ idx: prediction["pair_chains_iptm"][idx][idx][model_idx].item()
+ for idx in prediction["pair_chains_iptm"]
+ }
+ confidence_summary_dict["pair_chains_iptm"] = {
+ idx1: {
+ idx2: prediction["pair_chains_iptm"][idx1][idx2][
+ model_idx
+ ].item()
+ for idx2 in prediction["pair_chains_iptm"][idx1]
+ }
+ for idx1 in prediction["pair_chains_iptm"]
+ }
+ with path.open("w") as f:
+ f.write(
+ json.dumps(
+ confidence_summary_dict,
+ indent=4,
+ )
+ )
+
+ # Save plddt
+ plddt = prediction["plddt"][model_idx]
+ path = (
+ struct_dir
+ / f"plddt_{record.id}_model_{idx_to_rank[model_idx]}.npz"
+ )
+ np.savez_compressed(path, plddt=plddt.cpu().numpy())
+
+ # Save pae
+ if "pae" in prediction:
+ pae = prediction["pae"][model_idx]
+ path = (
+ struct_dir
+ / f"pae_{record.id}_model_{idx_to_rank[model_idx]}.npz"
+ )
+ np.savez_compressed(path, pae=pae.cpu().numpy())
+
+ # Save pde
+ if "pde" in prediction:
+ pde = prediction["pde"][model_idx]
+ path = (
+ struct_dir
+ / f"pde_{record.id}_model_{idx_to_rank[model_idx]}.npz"
+ )
+ np.savez_compressed(path, pde=pde.cpu().numpy())
+
+ # Save embeddings
+ if self.write_embeddings and "s" in prediction and "z" in prediction:
+ s = prediction["s"].cpu().numpy()
+ z = prediction["z"].cpu().numpy()
+
+ path = (
+ struct_dir
+ / f"embeddings_{record.id}.npz"
+ )
+ np.savez_compressed(path, s=s, z=z)
+
+ def on_predict_epoch_end(
+ self,
+ trainer: Trainer, # noqa: ARG002
+ pl_module: LightningModule, # noqa: ARG002
+ ) -> None:
+ """Print the number of failed examples."""
+ # Print number of failed examples
+ print(f"Number of failed examples: {self.failed}") # noqa: T201
+
+
+class BoltzAffinityWriter(BasePredictionWriter):
+ """Custom writer for predictions."""
+
+ def __init__(
+ self,
+ data_dir: str,
+ output_dir: str,
+ ) -> None:
+ """Initialize the writer.
+
+ Parameters
+ ----------
+ output_dir : str
+ The directory to save the predictions.
+
+ """
+ super().__init__(write_interval="batch")
+ self.failed = 0
+ self.data_dir = Path(data_dir)
+ self.output_dir = Path(output_dir)
+ self.output_dir.mkdir(parents=True, exist_ok=True)
+
+ def write_on_batch_end(
+ self,
+ trainer: Trainer, # noqa: ARG002
+ pl_module: LightningModule, # noqa: ARG002
+ prediction: dict[str, Tensor],
+ batch_indices: list[int], # noqa: ARG002
+ batch: dict[str, Tensor],
+ batch_idx: int, # noqa: ARG002
+ dataloader_idx: int, # noqa: ARG002
+ ) -> None:
+ """Write the predictions to disk."""
+ if prediction["exception"]:
+ self.failed += 1
+ return
+ # Dump affinity summary
+ affinity_summary = {}
+ pred_affinity_value = prediction["affinity_pred_value"]
+ pred_affinity_probability = prediction["affinity_probability_binary"]
+ affinity_summary = {
+ "affinity_pred_value": pred_affinity_value.item(),
+ "affinity_probability_binary": pred_affinity_probability.item(),
+ }
+ if "affinity_pred_value1" in prediction:
+ pred_affinity_value1 = prediction["affinity_pred_value1"]
+ pred_affinity_probability1 = prediction["affinity_probability_binary1"]
+ pred_affinity_value2 = prediction["affinity_pred_value2"]
+ pred_affinity_probability2 = prediction["affinity_probability_binary2"]
+ affinity_summary["affinity_pred_value1"] = pred_affinity_value1.item()
+ affinity_summary["affinity_probability_binary1"] = (
+ pred_affinity_probability1.item()
+ )
+ affinity_summary["affinity_pred_value2"] = pred_affinity_value2.item()
+ affinity_summary["affinity_probability_binary2"] = (
+ pred_affinity_probability2.item()
+ )
+
+ # Save the affinity summary
+ struct_dir = self.output_dir / batch["record"][0].id
+ struct_dir.mkdir(exist_ok=True)
+ path = struct_dir / f"affinity_{batch['record'][0].id}.json"
+
+ with path.open("w") as f:
+ f.write(json.dumps(affinity_summary, indent=4))
+
+ def on_predict_epoch_end(
+ self,
+ trainer: Trainer, # noqa: ARG002
+ pl_module: LightningModule, # noqa: ARG002
+ ) -> None:
+ """Print the number of failed examples."""
+ # Print number of failed examples
+ print(f"Number of failed examples: {self.failed}") # noqa: T201
diff --git a/forks/boltz/src/boltz/main.py b/forks/boltz/src/boltz/main.py
new file mode 100644
index 00000000..4a3750fe
--- /dev/null
+++ b/forks/boltz/src/boltz/main.py
@@ -0,0 +1,1414 @@
+import multiprocessing
+import os
+import pickle
+import platform
+import tarfile
+import urllib.request
+import warnings
+from dataclasses import asdict, dataclass
+from functools import partial
+from multiprocessing import Pool
+from pathlib import Path
+from typing import Literal, Optional
+
+import click
+import torch
+from pytorch_lightning import Trainer, seed_everything
+from pytorch_lightning.strategies import DDPStrategy
+from pytorch_lightning.utilities import rank_zero_only
+from rdkit import Chem
+from tqdm import tqdm
+
+from boltz.data import const
+from boltz.data.module.inference import BoltzInferenceDataModule
+from boltz.data.module.inferencev2 import Boltz2InferenceDataModule
+from boltz.data.mol import load_canonicals
+from boltz.data.msa.mmseqs2 import run_mmseqs2
+from boltz.data.parse.a3m import parse_a3m
+from boltz.data.parse.csv import parse_csv
+from boltz.data.parse.fasta import parse_fasta
+from boltz.data.parse.yaml import parse_yaml
+from boltz.data.types import MSA, Manifest, Record
+from boltz.data.write.writer import BoltzAffinityWriter, BoltzWriter
+from boltz.model.models.boltz1 import Boltz1
+from boltz.model.models.boltz2 import Boltz2
+
+CCD_URL = "https://huggingface.co/boltz-community/boltz-1/resolve/main/ccd.pkl"
+MOL_URL = "https://huggingface.co/boltz-community/boltz-2/resolve/main/mols.tar"
+
+BOLTZ1_URL_WITH_FALLBACK = [
+ "https://model-gateway.boltz.bio/boltz1_conf.ckpt",
+ "https://huggingface.co/boltz-community/boltz-1/resolve/main/boltz1_conf.ckpt",
+]
+
+BOLTZ2_URL_WITH_FALLBACK = [
+ "https://model-gateway.boltz.bio/boltz2_conf.ckpt",
+ "https://huggingface.co/boltz-community/boltz-2/resolve/main/boltz2_conf.ckpt",
+]
+
+BOLTZ2_AFFINITY_URL_WITH_FALLBACK = [
+ "https://model-gateway.boltz.bio/boltz2_aff.ckpt",
+ "https://huggingface.co/boltz-community/boltz-2/resolve/main/boltz2_aff.ckpt",
+]
+
+
+@dataclass
+class BoltzProcessedInput:
+ """Processed input data."""
+
+ manifest: Manifest
+ targets_dir: Path
+ msa_dir: Path
+ constraints_dir: Optional[Path] = None
+ template_dir: Optional[Path] = None
+ extra_mols_dir: Optional[Path] = None
+
+
+@dataclass
+class PairformerArgs:
+ """Pairformer arguments."""
+
+ num_blocks: int = 48
+ num_heads: int = 16
+ dropout: float = 0.0
+ activation_checkpointing: bool = False
+ offload_to_cpu: bool = False
+ v2: bool = False
+
+
+@dataclass
+class PairformerArgsV2:
+ """Pairformer arguments."""
+
+ num_blocks: int = 64
+ num_heads: int = 16
+ dropout: float = 0.0
+ activation_checkpointing: bool = False
+ offload_to_cpu: bool = False
+ v2: bool = True
+
+
+@dataclass
+class MSAModuleArgs:
+ """MSA module arguments."""
+
+ msa_s: int = 64
+ msa_blocks: int = 4
+ msa_dropout: float = 0.0
+ z_dropout: float = 0.0
+ use_paired_feature: bool = True
+ pairwise_head_width: int = 32
+ pairwise_num_heads: int = 4
+ activation_checkpointing: bool = False
+ offload_to_cpu: bool = False
+ subsample_msa: bool = False
+ num_subsampled_msa: int = 1024
+
+
+@dataclass
+class BoltzDiffusionParams:
+ """Diffusion process parameters."""
+
+ gamma_0: float = 0.605
+ gamma_min: float = 1.107
+ noise_scale: float = 0.901
+ rho: float = 8
+ step_scale: float = 1.638
+ sigma_min: float = 0.0004
+ sigma_max: float = 160.0
+ sigma_data: float = 16.0
+ P_mean: float = -1.2
+ P_std: float = 1.5
+ coordinate_augmentation: bool = True
+ alignment_reverse_diff: bool = True
+ synchronize_sigmas: bool = True
+ use_inference_model_cache: bool = True
+
+
+@dataclass
+class Boltz2DiffusionParams:
+ """Diffusion process parameters."""
+
+ gamma_0: float = 0.8
+ gamma_min: float = 1.0
+ noise_scale: float = 1.003
+ rho: float = 7
+ step_scale: float = 1.5
+ sigma_min: float = 0.0001
+ sigma_max: float = 160.0
+ sigma_data: float = 16.0
+ P_mean: float = -1.2
+ P_std: float = 1.5
+ coordinate_augmentation: bool = True
+ alignment_reverse_diff: bool = True
+ synchronize_sigmas: bool = True
+
+
+@dataclass
+class BoltzSteeringParams:
+ """Steering parameters."""
+
+ fk_steering: bool = False
+ num_particles: int = 3
+ fk_lambda: float = 4.0
+ fk_resampling_interval: int = 3
+ physical_guidance_update: bool = False
+ contact_guidance_update: bool = True
+ num_gd_steps: int = 20
+
+
+@rank_zero_only
+def download_boltz1(cache: Path) -> None:
+ """Download all the required data.
+
+ Parameters
+ ----------
+ cache : Path
+ The cache directory.
+
+ """
+ # Download CCD
+ ccd = cache / "ccd.pkl"
+ if not ccd.exists():
+ click.echo(
+ f"Downloading the CCD dictionary to {ccd}. You may "
+ "change the cache directory with the --cache flag."
+ )
+ urllib.request.urlretrieve(CCD_URL, str(ccd)) # noqa: S310
+
+ # Download model
+ model = cache / "boltz1_conf.ckpt"
+ if not model.exists():
+ click.echo(
+ f"Downloading the model weights to {model}. You may "
+ "change the cache directory with the --cache flag."
+ )
+ for i, url in enumerate(BOLTZ1_URL_WITH_FALLBACK):
+ try:
+ urllib.request.urlretrieve(url, str(model)) # noqa: S310
+ break
+ except Exception as e: # noqa: BLE001
+ if i == len(BOLTZ1_URL_WITH_FALLBACK) - 1:
+ msg = f"Failed to download model from all URLs. Last error: {e}"
+ raise RuntimeError(msg) from e
+ continue
+
+
+@rank_zero_only
+def download_boltz2(cache: Path) -> None:
+ """Download all the required data.
+
+ Parameters
+ ----------
+ cache : Path
+ The cache directory.
+
+ """
+ # Download CCD
+ mols = cache / "mols"
+ tar_mols = cache / "mols.tar"
+ if not tar_mols.exists():
+ click.echo(
+ f"Downloading the CCD data to {tar_mols}. "
+ "This may take a bit of time. You may change the cache directory "
+ "with the --cache flag."
+ )
+ urllib.request.urlretrieve(MOL_URL, str(tar_mols)) # noqa: S310
+ if not mols.exists():
+ click.echo(
+ f"Extracting the CCD data to {mols}. "
+ "This may take a bit of time. You may change the cache directory "
+ "with the --cache flag."
+ )
+ with tarfile.open(str(tar_mols), "r") as tar:
+ tar.extractall(cache) # noqa: S202
+
+ # Download model
+ model = cache / "boltz2_conf.ckpt"
+ if not model.exists():
+ click.echo(
+ f"Downloading the Boltz-2 weights to {model}. You may "
+ "change the cache directory with the --cache flag."
+ )
+ for i, url in enumerate(BOLTZ2_URL_WITH_FALLBACK):
+ try:
+ urllib.request.urlretrieve(url, str(model)) # noqa: S310
+ break
+ except Exception as e: # noqa: BLE001
+ if i == len(BOLTZ2_URL_WITH_FALLBACK) - 1:
+ msg = f"Failed to download model from all URLs. Last error: {e}"
+ raise RuntimeError(msg) from e
+ continue
+
+ # Download affinity model
+ affinity_model = cache / "boltz2_aff.ckpt"
+ if not affinity_model.exists():
+ click.echo(
+ f"Downloading the Boltz-2 affinity weights to {affinity_model}. You may "
+ "change the cache directory with the --cache flag."
+ )
+ for i, url in enumerate(BOLTZ2_AFFINITY_URL_WITH_FALLBACK):
+ try:
+ urllib.request.urlretrieve(url, str(affinity_model)) # noqa: S310
+ break
+ except Exception as e: # noqa: BLE001
+ if i == len(BOLTZ2_AFFINITY_URL_WITH_FALLBACK) - 1:
+ msg = f"Failed to download model from all URLs. Last error: {e}"
+ raise RuntimeError(msg) from e
+ continue
+
+
+def get_cache_path() -> str:
+ """Determine the cache path, prioritising the BOLTZ_CACHE environment variable.
+
+ Returns
+ -------
+ str: Path
+ Path to use for boltz cache location.
+
+ """
+ env_cache = os.environ.get("BOLTZ_CACHE")
+ if env_cache:
+ resolved_cache = Path(env_cache).expanduser().resolve()
+ if not resolved_cache.is_absolute():
+ msg = f"BOLTZ_CACHE must be an absolute path, got: {env_cache}"
+ raise ValueError(msg)
+ return str(resolved_cache)
+
+ return str(Path("~/.boltz").expanduser())
+
+
+def check_inputs(data: Path) -> list[Path]:
+ """Check the input data and output directory.
+
+ Parameters
+ ----------
+ data : Path
+ The input data.
+
+ Returns
+ -------
+ list[Path]
+ The list of input data.
+
+ """
+ click.echo("Checking input data.")
+
+ # Check if data is a directory
+ if data.is_dir():
+ data: list[Path] = list(data.glob("*"))
+
+ # Filter out non .fasta or .yaml files, raise
+ # an error on directory and other file types
+ for d in data:
+ if d.is_dir():
+ msg = f"Found directory {d} instead of .fasta or .yaml."
+ raise RuntimeError(msg)
+ if d.suffix.lower() not in (".fa", ".fas", ".fasta", ".yml", ".yaml"):
+ msg = (
+ f"Unable to parse filetype {d.suffix}, "
+ "please provide a .fasta or .yaml file."
+ )
+ raise RuntimeError(msg)
+ else:
+ data = [data]
+
+ return data
+
+
+def filter_inputs_structure(
+ manifest: Manifest,
+ outdir: Path,
+ override: bool = False,
+) -> Manifest:
+ """Filter the manifest to only include missing predictions.
+
+ Parameters
+ ----------
+ manifest : Manifest
+ The manifest of the input data.
+ outdir : Path
+ The output directory.
+ override: bool
+ Whether to override existing predictions.
+
+ Returns
+ -------
+ Manifest
+ The manifest of the filtered input data.
+
+ """
+ # Check if existing predictions are found (only top-level prediction folders)
+ pred_dir = outdir / "predictions"
+ if pred_dir.exists():
+ existing = {d.name for d in pred_dir.iterdir() if d.is_dir()}
+ else:
+ existing = set()
+
+ # Remove them from the input data
+ if existing and not override:
+ manifest = Manifest([r for r in manifest.records if r.id not in existing])
+ msg = (
+ f"Found some existing predictions ({len(existing)}), "
+ f"skipping and running only the missing ones, "
+ "if any. If you wish to override these existing "
+ "predictions, please set the --override flag."
+ )
+ click.echo(msg)
+ elif existing and override:
+ msg = f"Found {len(existing)} existing predictions, will override."
+ click.echo(msg)
+
+ return manifest
+
+
+def filter_inputs_affinity(
+ manifest: Manifest,
+ outdir: Path,
+ override: bool = False,
+) -> Manifest:
+ """Check the input data and output directory for affinity.
+
+ Parameters
+ ----------
+ manifest : Manifest
+ The manifest.
+ outdir : Path
+ The output directory.
+ override: bool
+ Whether to override existing predictions.
+
+ Returns
+ -------
+ Manifest
+ The manifest of the filtered input data.
+
+ """
+ click.echo("Checking input data for affinity.")
+
+ # Get all affinity targets
+ existing = {
+ r.id
+ for r in manifest.records
+ if r.affinity
+ and (outdir / "predictions" / r.id / f"affinity_{r.id}.json").exists()
+ }
+
+ # Remove them from the input data
+ if existing and not override:
+ manifest = Manifest([r for r in manifest.records if r.id not in existing])
+ num_skipped = len(existing)
+ msg = (
+ f"Found some existing affinity predictions ({num_skipped}), "
+ f"skipping and running only the missing ones, "
+ "if any. If you wish to override these existing "
+ "affinity predictions, please set the --override flag."
+ )
+ click.echo(msg)
+ elif existing and override:
+ msg = "Found existing affinity predictions, will override."
+ click.echo(msg)
+
+ return manifest
+
+
+def compute_msa(
+ data: dict[str, str],
+ target_id: str,
+ msa_dir: Path,
+ msa_server_url: str,
+ msa_pairing_strategy: str,
+ msa_server_username: Optional[str] = None,
+ msa_server_password: Optional[str] = None,
+ api_key_header: Optional[str] = None,
+ api_key_value: Optional[str] = None,
+) -> None:
+ """Compute the MSA for the input data.
+
+ Parameters
+ ----------
+ data : dict[str, str]
+ The input protein sequences.
+ target_id : str
+ The target id.
+ msa_dir : Path
+ The msa directory.
+ msa_server_url : str
+ The MSA server URL.
+ msa_pairing_strategy : str
+ The MSA pairing strategy.
+ msa_server_username : str, optional
+ Username for basic authentication with MSA server.
+ msa_server_password : str, optional
+ Password for basic authentication with MSA server.
+ api_key_header : str, optional
+ Custom header key for API key authentication (default: X-API-Key).
+ api_key_value : str, optional
+ Custom header value for API key authentication (overrides --api_key if set).
+
+ """
+ click.echo(f"Calling MSA server for target {target_id} with {len(data)} sequences")
+ click.echo(f"MSA server URL: {msa_server_url}")
+ click.echo(f"MSA pairing strategy: {msa_pairing_strategy}")
+
+ # Construct auth headers if API key header/value is provided
+ auth_headers = None
+ if api_key_value:
+ key = api_key_header if api_key_header else "X-API-Key"
+ value = api_key_value
+ auth_headers = {
+ "Content-Type": "application/json",
+ key: value
+ }
+ click.echo(f"Using API key authentication for MSA server (header: {key})")
+ elif msa_server_username and msa_server_password:
+ click.echo("Using basic authentication for MSA server")
+ else:
+ click.echo("No authentication provided for MSA server")
+
+ if len(data) > 1:
+ paired_msas = run_mmseqs2(
+ list(data.values()),
+ msa_dir / f"{target_id}_paired_tmp",
+ use_env=True,
+ use_pairing=True,
+ host_url=msa_server_url,
+ pairing_strategy=msa_pairing_strategy,
+ msa_server_username=msa_server_username,
+ msa_server_password=msa_server_password,
+ auth_headers=auth_headers,
+ )
+ else:
+ paired_msas = [""] * len(data)
+
+ unpaired_msa = run_mmseqs2(
+ list(data.values()),
+ msa_dir / f"{target_id}_unpaired_tmp",
+ use_env=True,
+ use_pairing=False,
+ host_url=msa_server_url,
+ pairing_strategy=msa_pairing_strategy,
+ msa_server_username=msa_server_username,
+ msa_server_password=msa_server_password,
+ auth_headers=auth_headers,
+ )
+
+ for idx, name in enumerate(data):
+ # Get paired sequences
+ paired = paired_msas[idx].strip().splitlines()
+ paired = paired[1::2] # ignore headers
+ paired = paired[: const.max_paired_seqs]
+
+ # Set key per row and remove empty sequences
+ keys = [idx for idx, s in enumerate(paired) if s != "-" * len(s)]
+ paired = [s for s in paired if s != "-" * len(s)]
+
+ # Combine paired-unpaired sequences
+ unpaired = unpaired_msa[idx].strip().splitlines()
+ unpaired = unpaired[1::2]
+ unpaired = unpaired[: (const.max_msa_seqs - len(paired))]
+ if paired:
+ unpaired = unpaired[1:] # ignore query is already present
+
+ # Combine
+ seqs = paired + unpaired
+ keys = keys + [-1] * len(unpaired)
+
+ # Dump MSA
+ csv_str = ["key,sequence"] + [f"{key},{seq}" for key, seq in zip(keys, seqs)]
+
+ msa_path = msa_dir / f"{name}.csv"
+ with msa_path.open("w") as f:
+ f.write("\n".join(csv_str))
+
+
+def process_input( # noqa: C901, PLR0912, PLR0915, D103
+ path: Path,
+ ccd: dict,
+ msa_dir: Path,
+ mol_dir: Path,
+ boltz2: bool,
+ use_msa_server: bool,
+ msa_server_url: str,
+ msa_pairing_strategy: str,
+ msa_server_username: Optional[str],
+ msa_server_password: Optional[str],
+ api_key_header: Optional[str],
+ api_key_value: Optional[str],
+ max_msa_seqs: int,
+ processed_msa_dir: Path,
+ processed_constraints_dir: Path,
+ processed_templates_dir: Path,
+ processed_mols_dir: Path,
+ structure_dir: Path,
+ records_dir: Path,
+) -> None:
+ try:
+ # Parse data
+ if path.suffix.lower() in (".fa", ".fas", ".fasta"):
+ target = parse_fasta(path, ccd, mol_dir, boltz2)
+ elif path.suffix.lower() in (".yml", ".yaml"):
+ target = parse_yaml(path, ccd, mol_dir, boltz2)
+ elif path.is_dir():
+ msg = f"Found directory {path} instead of .fasta or .yaml, skipping."
+ raise RuntimeError(msg) # noqa: TRY301
+ else:
+ msg = (
+ f"Unable to parse filetype {path.suffix}, "
+ "please provide a .fasta or .yaml file."
+ )
+ raise RuntimeError(msg) # noqa: TRY301
+
+ # Get target id
+ target_id = target.record.id
+
+ # Get all MSA ids and decide whether to generate MSA
+ to_generate = {}
+ prot_id = const.chain_type_ids["PROTEIN"]
+ for chain in target.record.chains:
+ # Add to generate list, assigning entity id
+ if (chain.mol_type == prot_id) and (chain.msa_id == 0):
+ entity_id = chain.entity_id
+ msa_id = f"{target_id}_{entity_id}"
+ to_generate[msa_id] = target.sequences[entity_id]
+ chain.msa_id = msa_dir / f"{msa_id}.csv"
+
+ # We do not support msa generation for non-protein chains
+ elif chain.msa_id == 0:
+ chain.msa_id = -1
+
+ # Generate MSA
+ if to_generate and not use_msa_server:
+ msg = "Missing MSA's in input and --use_msa_server flag not set."
+ raise RuntimeError(msg) # noqa: TRY301
+
+ if to_generate:
+ msg = f"Generating MSA for {path} with {len(to_generate)} protein entities."
+ click.echo(msg)
+ compute_msa(
+ data=to_generate,
+ target_id=target_id,
+ msa_dir=msa_dir,
+ msa_server_url=msa_server_url,
+ msa_pairing_strategy=msa_pairing_strategy,
+ msa_server_username=msa_server_username,
+ msa_server_password=msa_server_password,
+ api_key_header=api_key_header,
+ api_key_value=api_key_value,
+ )
+
+ # Parse MSA data
+ msas = sorted({c.msa_id for c in target.record.chains if c.msa_id != -1})
+ msa_id_map = {}
+ for msa_idx, msa_id in enumerate(msas):
+ # Check that raw MSA exists
+ msa_path = Path(msa_id)
+ if not msa_path.exists():
+ msg = f"MSA file {msa_path} not found."
+ raise FileNotFoundError(msg) # noqa: TRY301
+
+ # Dump processed MSA
+ processed = processed_msa_dir / f"{target_id}_{msa_idx}.npz"
+ msa_id_map[msa_id] = f"{target_id}_{msa_idx}"
+ if not processed.exists():
+ # Parse A3M
+ if msa_path.suffix == ".a3m":
+ msa: MSA = parse_a3m(
+ msa_path,
+ taxonomy=None,
+ max_seqs=max_msa_seqs,
+ )
+ elif msa_path.suffix == ".csv":
+ msa: MSA = parse_csv(msa_path, max_seqs=max_msa_seqs)
+ else:
+ msg = f"MSA file {msa_path} not supported, only a3m or csv."
+ raise RuntimeError(msg) # noqa: TRY301
+
+ msa.dump(processed)
+
+ # Modify records to point to processed MSA
+ for c in target.record.chains:
+ if (c.msa_id != -1) and (c.msa_id in msa_id_map):
+ c.msa_id = msa_id_map[c.msa_id]
+
+ # Dump templates
+ for template_id, template in target.templates.items():
+ name = f"{target.record.id}_{template_id}.npz"
+ template_path = processed_templates_dir / name
+ template.dump(template_path)
+
+ # Dump constraints
+ constraints_path = processed_constraints_dir / f"{target.record.id}.npz"
+ target.residue_constraints.dump(constraints_path)
+
+ # Dump extra molecules
+ Chem.SetDefaultPickleProperties(Chem.PropertyPickleOptions.AllProps)
+ with (processed_mols_dir / f"{target.record.id}.pkl").open("wb") as f:
+ pickle.dump(target.extra_mols, f)
+
+ # Dump structure
+ struct_path = structure_dir / f"{target.record.id}.npz"
+ target.structure.dump(struct_path)
+
+ # Dump record
+ record_path = records_dir / f"{target.record.id}.json"
+ target.record.dump(record_path)
+
+ except Exception as e: # noqa: BLE001
+ import traceback
+
+ traceback.print_exc()
+ print(f"Failed to process {path}. Skipping. Error: {e}.") # noqa: T201
+
+
+@rank_zero_only
+def process_inputs(
+ data: list[Path],
+ out_dir: Path,
+ ccd_path: Path,
+ mol_dir: Path,
+ msa_server_url: str,
+ msa_pairing_strategy: str,
+ max_msa_seqs: int = 8192,
+ use_msa_server: bool = False,
+ msa_server_username: Optional[str] = None,
+ msa_server_password: Optional[str] = None,
+ api_key_header: Optional[str] = None,
+ api_key_value: Optional[str] = None,
+ boltz2: bool = False,
+ preprocessing_threads: int = 1,
+) -> Manifest:
+ """Process the input data and output directory.
+
+ Parameters
+ ----------
+ data : list[Path]
+ The input data.
+ out_dir : Path
+ The output directory.
+ ccd_path : Path
+ The path to the CCD dictionary.
+ max_msa_seqs : int, optional
+ Max number of MSA sequences, by default 8192.
+ use_msa_server : bool, optional
+ Whether to use the MMSeqs2 server for MSA generation, by default False.
+ msa_server_username : str, optional
+ Username for basic authentication with MSA server, by default None.
+ msa_server_password : str, optional
+ Password for basic authentication with MSA server, by default None.
+ api_key_header : str, optional
+ Custom header key for API key authentication (default: X-API-Key).
+ api_key_value : str, optional
+ Custom header value for API key authentication (overrides --api_key if set).
+ boltz2: bool, optional
+ Whether to use Boltz2, by default False.
+ preprocessing_threads: int, optional
+ The number of threads to use for preprocessing, by default 1.
+
+ Returns
+ -------
+ Manifest
+ The manifest of the processed input data.
+
+ """
+ # Validate mutually exclusive authentication methods
+ has_basic_auth = msa_server_username and msa_server_password
+ has_api_key = api_key_value is not None
+
+ if has_basic_auth and has_api_key:
+ raise ValueError(
+ "Cannot use both basic authentication (--msa_server_username/--msa_server_password) "
+ "and API key authentication (--api_key_header/--api_key_value). Please use only one authentication method."
+ )
+
+ # Check if records exist at output path
+ records_dir = out_dir / "processed" / "records"
+ if records_dir.exists():
+ # Load existing records
+ existing = [Record.load(p) for p in records_dir.glob("*.json")]
+ processed_ids = {record.id for record in existing}
+
+ # Filter to missing only
+ data = [d for d in data if d.stem not in processed_ids]
+
+ # Nothing to do, update the manifest and return
+ if data:
+ click.echo(
+ f"Found {len(existing)} existing processed inputs, skipping them."
+ )
+ else:
+ click.echo("All inputs are already processed.")
+ updated_manifest = Manifest(existing)
+ updated_manifest.dump(out_dir / "processed" / "manifest.json")
+
+ # Create output directories
+ msa_dir = out_dir / "msa"
+ records_dir = out_dir / "processed" / "records"
+ structure_dir = out_dir / "processed" / "structures"
+ processed_msa_dir = out_dir / "processed" / "msa"
+ processed_constraints_dir = out_dir / "processed" / "constraints"
+ processed_templates_dir = out_dir / "processed" / "templates"
+ processed_mols_dir = out_dir / "processed" / "mols"
+ predictions_dir = out_dir / "predictions"
+
+ out_dir.mkdir(parents=True, exist_ok=True)
+ msa_dir.mkdir(parents=True, exist_ok=True)
+ records_dir.mkdir(parents=True, exist_ok=True)
+ structure_dir.mkdir(parents=True, exist_ok=True)
+ processed_msa_dir.mkdir(parents=True, exist_ok=True)
+ processed_constraints_dir.mkdir(parents=True, exist_ok=True)
+ processed_templates_dir.mkdir(parents=True, exist_ok=True)
+ processed_mols_dir.mkdir(parents=True, exist_ok=True)
+ predictions_dir.mkdir(parents=True, exist_ok=True)
+
+ # Load CCD
+ if boltz2:
+ ccd = load_canonicals(mol_dir)
+ else:
+ with ccd_path.open("rb") as file:
+ ccd = pickle.load(file) # noqa: S301
+
+ # Create partial function
+ process_input_partial = partial(
+ process_input,
+ ccd=ccd,
+ msa_dir=msa_dir,
+ mol_dir=mol_dir,
+ boltz2=boltz2,
+ use_msa_server=use_msa_server,
+ msa_server_url=msa_server_url,
+ msa_pairing_strategy=msa_pairing_strategy,
+ msa_server_username=msa_server_username,
+ msa_server_password=msa_server_password,
+ api_key_header=api_key_header,
+ api_key_value=api_key_value,
+ max_msa_seqs=max_msa_seqs,
+ processed_msa_dir=processed_msa_dir,
+ processed_constraints_dir=processed_constraints_dir,
+ processed_templates_dir=processed_templates_dir,
+ processed_mols_dir=processed_mols_dir,
+ structure_dir=structure_dir,
+ records_dir=records_dir,
+ )
+
+ # Parse input data
+ preprocessing_threads = min(preprocessing_threads, len(data))
+ click.echo(f"Processing {len(data)} inputs with {preprocessing_threads} threads.")
+
+ if preprocessing_threads > 1 and len(data) > 1:
+ with Pool(preprocessing_threads) as pool:
+ list(tqdm(pool.imap(process_input_partial, data), total=len(data)))
+ else:
+ for path in tqdm(data):
+ process_input_partial(path)
+
+ # Load all records and write manifest
+ records = [Record.load(p) for p in records_dir.glob("*.json")]
+ manifest = Manifest(records)
+ manifest.dump(out_dir / "processed" / "manifest.json")
+
+
+@click.group()
+def cli() -> None:
+ """Boltz."""
+ return
+
+
+@cli.command()
+@click.argument("data", type=click.Path(exists=True))
+@click.option(
+ "--out_dir",
+ type=click.Path(exists=False),
+ help="The path where to save the predictions.",
+ default="./",
+)
+@click.option(
+ "--cache",
+ type=click.Path(exists=False),
+ help=(
+ "The directory where to download the data and model. "
+ "Default is ~/.boltz, or $BOLTZ_CACHE if set."
+ ),
+ default=get_cache_path,
+)
+@click.option(
+ "--checkpoint",
+ type=click.Path(exists=True),
+ help="An optional checkpoint, will use the provided Boltz-1 model by default.",
+ default=None,
+)
+@click.option(
+ "--devices",
+ type=int,
+ help="The number of devices to use for prediction. Default is 1.",
+ default=1,
+)
+@click.option(
+ "--accelerator",
+ type=click.Choice(["gpu", "cpu", "tpu"]),
+ help="The accelerator to use for prediction. Default is gpu.",
+ default="gpu",
+)
+@click.option(
+ "--recycling_steps",
+ type=int,
+ help="The number of recycling steps to use for prediction. Default is 3.",
+ default=3,
+)
+@click.option(
+ "--sampling_steps",
+ type=int,
+ help="The number of sampling steps to use for prediction. Default is 200.",
+ default=200,
+)
+@click.option(
+ "--diffusion_samples",
+ type=int,
+ help="The number of diffusion samples to use for prediction. Default is 1.",
+ default=1,
+)
+@click.option(
+ "--max_parallel_samples",
+ type=int,
+ help="The maximum number of samples to predict in parallel. Default is None.",
+ default=5,
+)
+@click.option(
+ "--step_scale",
+ type=float,
+ help=(
+ "The step size is related to the temperature at "
+ "which the diffusion process samples the distribution. "
+ "The lower the higher the diversity among samples "
+ "(recommended between 1 and 2). "
+ "Default is 1.638 for Boltz-1 and 1.5 for Boltz-2. "
+ "If not provided, the default step size will be used."
+ ),
+ default=None,
+)
+@click.option(
+ "--write_full_pae",
+ type=bool,
+ is_flag=True,
+ help="Whether to dump the pae into a npz file. Default is True.",
+)
+@click.option(
+ "--write_full_pde",
+ type=bool,
+ is_flag=True,
+ help="Whether to dump the pde into a npz file. Default is False.",
+)
+@click.option(
+ "--output_format",
+ type=click.Choice(["pdb", "mmcif"]),
+ help="The output format to use for the predictions. Default is mmcif.",
+ default="mmcif",
+)
+@click.option(
+ "--num_workers",
+ type=int,
+ help="The number of dataloader workers to use for prediction. Default is 2.",
+ default=2,
+)
+@click.option(
+ "--override",
+ is_flag=True,
+ help="Whether to override existing found predictions. Default is False.",
+)
+@click.option(
+ "--seed",
+ type=int,
+ help="Seed to use for random number generator. Default is None (no seeding).",
+ default=None,
+)
+@click.option(
+ "--use_msa_server",
+ is_flag=True,
+ help="Whether to use the MMSeqs2 server for MSA generation. Default is False.",
+)
+@click.option(
+ "--msa_server_url",
+ type=str,
+ help="MSA server url. Used only if --use_msa_server is set. ",
+ default="https://api.colabfold.com",
+)
+@click.option(
+ "--msa_pairing_strategy",
+ type=str,
+ help=(
+ "Pairing strategy to use. Used only if --use_msa_server is set. "
+ "Options are 'greedy' and 'complete'"
+ ),
+ default="greedy",
+)
+@click.option(
+ "--msa_server_username",
+ type=str,
+ help="MSA server username for basic auth. Used only if --use_msa_server is set. Can also be set via BOLTZ_MSA_USERNAME environment variable.",
+ default=None,
+)
+@click.option(
+ "--msa_server_password",
+ type=str,
+ help="MSA server password for basic auth. Used only if --use_msa_server is set. Can also be set via BOLTZ_MSA_PASSWORD environment variable.",
+ default=None,
+)
+@click.option(
+ "--api_key_header",
+ type=str,
+ help="Custom header key for API key authentication (default: X-API-Key).",
+ default=None,
+)
+@click.option(
+ "--api_key_value",
+ type=str,
+ help="Custom header value for API key authentication.",
+ default=None,
+)
+@click.option(
+ "--use_potentials",
+ is_flag=True,
+ help="Whether to use potentials for steering. Default is False.",
+)
+@click.option(
+ "--model",
+ default="boltz2",
+ type=click.Choice(["boltz1", "boltz2"]),
+ help="The model to use for prediction. Default is boltz2.",
+)
+@click.option(
+ "--method",
+ type=str,
+ help="The method to use for prediction. Default is None.",
+ default=None,
+)
+@click.option(
+ "--preprocessing-threads",
+ type=int,
+ help="The number of threads to use for preprocessing. Default is 1.",
+ default=multiprocessing.cpu_count(),
+)
+@click.option(
+ "--affinity_mw_correction",
+ is_flag=True,
+ type=bool,
+ help="Whether to add the Molecular Weight correction to the affinity value head.",
+)
+@click.option(
+ "--sampling_steps_affinity",
+ type=int,
+ help="The number of sampling steps to use for affinity prediction. Default is 200.",
+ default=200,
+)
+@click.option(
+ "--diffusion_samples_affinity",
+ type=int,
+ help="The number of diffusion samples to use for affinity prediction. Default is 5.",
+ default=5,
+)
+@click.option(
+ "--affinity_checkpoint",
+ type=click.Path(exists=True),
+ help="An optional checkpoint, will use the provided Boltz-1 model by default.",
+ default=None,
+)
+@click.option(
+ "--max_msa_seqs",
+ type=int,
+ help="The maximum number of MSA sequences to use for prediction. Default is 8192.",
+ default=8192,
+)
+@click.option(
+ "--subsample_msa",
+ is_flag=True,
+ help="Whether to subsample the MSA. Default is True.",
+)
+@click.option(
+ "--num_subsampled_msa",
+ type=int,
+ help="The number of MSA sequences to subsample. Default is 1024.",
+ default=1024,
+)
+@click.option(
+ "--no_kernels",
+ is_flag=True,
+ help="Whether to disable the kernels. Default False",
+)
+@click.option(
+ "--write_embeddings",
+ is_flag=True,
+ help=" to dump the s and z embeddings into a npz file. Default is False.",
+)
+def predict( # noqa: C901, PLR0915, PLR0912
+ data: str,
+ out_dir: str,
+ cache: str = "~/.boltz",
+ checkpoint: Optional[str] = None,
+ affinity_checkpoint: Optional[str] = None,
+ devices: int = 1,
+ accelerator: str = "gpu",
+ recycling_steps: int = 3,
+ sampling_steps: int = 200,
+ diffusion_samples: int = 1,
+ sampling_steps_affinity: int = 200,
+ diffusion_samples_affinity: int = 3,
+ max_parallel_samples: Optional[int] = None,
+ step_scale: Optional[float] = None,
+ write_full_pae: bool = False,
+ write_full_pde: bool = False,
+ output_format: Literal["pdb", "mmcif"] = "mmcif",
+ num_workers: int = 2,
+ override: bool = False,
+ seed: Optional[int] = None,
+ use_msa_server: bool = False,
+ msa_server_url: str = "https://api.colabfold.com",
+ msa_pairing_strategy: str = "greedy",
+ msa_server_username: Optional[str] = None,
+ msa_server_password: Optional[str] = None,
+ api_key_header: Optional[str] = None,
+ api_key_value: Optional[str] = None,
+ use_potentials: bool = False,
+ model: Literal["boltz1", "boltz2"] = "boltz2",
+ method: Optional[str] = None,
+ affinity_mw_correction: Optional[bool] = False,
+ preprocessing_threads: int = 1,
+ max_msa_seqs: int = 8192,
+ subsample_msa: bool = True,
+ num_subsampled_msa: int = 1024,
+ no_kernels: bool = False,
+ write_embeddings: bool = False,
+) -> None:
+ """Run predictions with Boltz."""
+ # If cpu, write a friendly warning
+ if accelerator == "cpu":
+ msg = "Running on CPU, this will be slow. Consider using a GPU."
+ click.echo(msg)
+
+ # Supress some lightning warnings
+ warnings.filterwarnings(
+ "ignore", ".*that has Tensor Cores. To properly utilize them.*"
+ )
+
+ # Set no grad
+ torch.set_grad_enabled(False)
+
+ # Ignore matmul precision warning
+ torch.set_float32_matmul_precision("highest")
+
+ # Set rdkit pickle logic
+ Chem.SetDefaultPickleProperties(Chem.PropertyPickleOptions.AllProps)
+
+ # Set seed if desired
+ if seed is not None:
+ seed_everything(seed)
+
+ for key in ["CUEQ_DEFAULT_CONFIG", "CUEQ_DISABLE_AOT_TUNING"]:
+ # Disable kernel tuning by default,
+ # but do not modify envvar if already set by caller
+ os.environ[key] = os.environ.get(key, "1")
+
+ # Set cache path
+ cache = Path(cache).expanduser()
+ cache.mkdir(parents=True, exist_ok=True)
+
+ # Get MSA server credentials from environment variables if not provided
+ if use_msa_server:
+ if msa_server_username is None:
+ msa_server_username = os.environ.get("BOLTZ_MSA_USERNAME")
+ if msa_server_password is None:
+ msa_server_password = os.environ.get("BOLTZ_MSA_PASSWORD")
+ if api_key_value is None:
+ api_key_value = os.environ.get("MSA_API_KEY_VALUE")
+
+ click.echo(f"MSA server enabled: {msa_server_url}")
+ if api_key_value:
+ click.echo("MSA server authentication: using API key header")
+ elif msa_server_username and msa_server_password:
+ click.echo("MSA server authentication: using basic auth")
+ else:
+ click.echo("MSA server authentication: no credentials provided")
+
+ # Create output directories
+ data = Path(data).expanduser()
+ out_dir = Path(out_dir).expanduser()
+ out_dir = out_dir / f"boltz_results_{data.stem}"
+ out_dir.mkdir(parents=True, exist_ok=True)
+
+ # Download necessary data and model
+ if model == "boltz1":
+ download_boltz1(cache)
+ elif model == "boltz2":
+ download_boltz2(cache)
+ else:
+ msg = f"Model {model} not supported. Supported: boltz1, boltz2."
+ raise ValueError(f"Model {model} not supported.")
+
+ # Validate inputs
+ data = check_inputs(data)
+
+ # Check method
+ if method is not None:
+ if model == "boltz1":
+ msg = "Method conditioning is not supported for Boltz-1."
+ raise ValueError(msg)
+ if method.lower() not in const.method_types_ids:
+ method_names = list(const.method_types_ids.keys())
+ msg = f"Method {method} not supported. Supported: {method_names}"
+ raise ValueError(msg)
+
+ # Process inputs
+ ccd_path = cache / "ccd.pkl"
+ mol_dir = cache / "mols"
+ process_inputs(
+ data=data,
+ out_dir=out_dir,
+ ccd_path=ccd_path,
+ mol_dir=mol_dir,
+ use_msa_server=use_msa_server,
+ msa_server_url=msa_server_url,
+ msa_pairing_strategy=msa_pairing_strategy,
+ msa_server_username=msa_server_username,
+ msa_server_password=msa_server_password,
+ api_key_header=api_key_header,
+ api_key_value=api_key_value,
+ boltz2=model == "boltz2",
+ preprocessing_threads=preprocessing_threads,
+ max_msa_seqs=max_msa_seqs,
+ )
+
+ # Load manifest
+ manifest = Manifest.load(out_dir / "processed" / "manifest.json")
+
+ # Filter out existing predictions
+ filtered_manifest = filter_inputs_structure(
+ manifest=manifest,
+ outdir=out_dir,
+ override=override,
+ )
+
+ # Load processed data
+ processed_dir = out_dir / "processed"
+ processed = BoltzProcessedInput(
+ manifest=filtered_manifest,
+ targets_dir=processed_dir / "structures",
+ msa_dir=processed_dir / "msa",
+ constraints_dir=(
+ (processed_dir / "constraints")
+ if (processed_dir / "constraints").exists()
+ else None
+ ),
+ template_dir=(
+ (processed_dir / "templates")
+ if (processed_dir / "templates").exists()
+ else None
+ ),
+ extra_mols_dir=(
+ (processed_dir / "mols") if (processed_dir / "mols").exists() else None
+ ),
+ )
+
+ # Set up trainer
+ strategy = "auto"
+ if (isinstance(devices, int) and devices > 1) or (
+ isinstance(devices, list) and len(devices) > 1
+ ):
+ start_method = "fork" if platform.system() != "win32" and platform.system() != "Windows" else "spawn"
+ strategy = DDPStrategy(start_method=start_method)
+ if len(filtered_manifest.records) < devices:
+ msg = (
+ "Number of requested devices is greater "
+ "than the number of predictions, taking the minimum."
+ )
+ click.echo(msg)
+ if isinstance(devices, list):
+ devices = devices[: max(1, len(filtered_manifest.records))]
+ else:
+ devices = max(1, min(len(filtered_manifest.records), devices))
+
+ # Set up model parameters
+ if model == "boltz2":
+ diffusion_params = Boltz2DiffusionParams()
+ step_scale = 1.5 if step_scale is None else step_scale
+ diffusion_params.step_scale = step_scale
+ pairformer_args = PairformerArgsV2()
+ else:
+ diffusion_params = BoltzDiffusionParams()
+ step_scale = 1.638 if step_scale is None else step_scale
+ diffusion_params.step_scale = step_scale
+ pairformer_args = PairformerArgs()
+
+ msa_args = MSAModuleArgs(
+ subsample_msa=subsample_msa,
+ num_subsampled_msa=num_subsampled_msa,
+ use_paired_feature=model == "boltz2",
+ )
+
+ # Create prediction writer
+ pred_writer = BoltzWriter(
+ data_dir=processed.targets_dir,
+ output_dir=out_dir / "predictions",
+ output_format=output_format,
+ boltz2=model == "boltz2",
+ write_embeddings=write_embeddings,
+ )
+
+ # Set up trainer
+ trainer = Trainer(
+ default_root_dir=out_dir,
+ strategy=strategy,
+ callbacks=[pred_writer],
+ accelerator=accelerator,
+ devices=devices,
+ precision=32 if model == "boltz1" else "bf16-mixed",
+ )
+
+ if filtered_manifest.records:
+ msg = f"Running structure prediction for {len(filtered_manifest.records)} input"
+ msg += "s." if len(filtered_manifest.records) > 1 else "."
+ click.echo(msg)
+
+ # Create data module
+ if model == "boltz2":
+ data_module = Boltz2InferenceDataModule(
+ manifest=processed.manifest,
+ target_dir=processed.targets_dir,
+ msa_dir=processed.msa_dir,
+ mol_dir=mol_dir,
+ num_workers=num_workers,
+ constraints_dir=processed.constraints_dir,
+ template_dir=processed.template_dir,
+ extra_mols_dir=processed.extra_mols_dir,
+ override_method=method,
+ )
+ else:
+ data_module = BoltzInferenceDataModule(
+ manifest=processed.manifest,
+ target_dir=processed.targets_dir,
+ msa_dir=processed.msa_dir,
+ num_workers=num_workers,
+ constraints_dir=processed.constraints_dir,
+ )
+
+ # Load model
+ if checkpoint is None:
+ if model == "boltz2":
+ checkpoint = cache / "boltz2_conf.ckpt"
+ else:
+ checkpoint = cache / "boltz1_conf.ckpt"
+
+ predict_args = {
+ "recycling_steps": recycling_steps,
+ "sampling_steps": sampling_steps,
+ "diffusion_samples": diffusion_samples,
+ "max_parallel_samples": max_parallel_samples,
+ "write_confidence_summary": True,
+ "write_full_pae": write_full_pae,
+ "write_full_pde": write_full_pde,
+ }
+
+ steering_args = BoltzSteeringParams()
+ steering_args.fk_steering = use_potentials
+ steering_args.physical_guidance_update = use_potentials
+
+ model_cls = Boltz2 if model == "boltz2" else Boltz1
+ model_module = model_cls.load_from_checkpoint(
+ checkpoint,
+ strict=True,
+ predict_args=predict_args,
+ map_location="cpu",
+ diffusion_process_args=asdict(diffusion_params),
+ ema=False,
+ use_kernels=not no_kernels,
+ pairformer_args=asdict(pairformer_args),
+ msa_args=asdict(msa_args),
+ steering_args=asdict(steering_args),
+ )
+ model_module.eval()
+
+ # Compute structure predictions
+ trainer.predict(
+ model_module,
+ datamodule=data_module,
+ return_predictions=False,
+ )
+
+ # Check if affinity predictions are needed
+ if any(r.affinity for r in manifest.records):
+ # Print header
+ click.echo("\nPredicting property: affinity\n")
+
+ # Validate inputs
+ manifest_filtered = filter_inputs_affinity(
+ manifest=manifest,
+ outdir=out_dir,
+ override=override,
+ )
+ if not manifest_filtered.records:
+ click.echo("Found existing affinity predictions for all inputs, skipping.")
+ return
+
+ msg = f"Running affinity prediction for {len(manifest_filtered.records)} input"
+ msg += "s." if len(manifest_filtered.records) > 1 else "."
+ click.echo(msg)
+
+ pred_writer = BoltzAffinityWriter(
+ data_dir=processed.targets_dir,
+ output_dir=out_dir / "predictions",
+ )
+
+ data_module = Boltz2InferenceDataModule(
+ manifest=manifest_filtered,
+ target_dir=out_dir / "predictions",
+ msa_dir=processed.msa_dir,
+ mol_dir=mol_dir,
+ num_workers=num_workers,
+ constraints_dir=processed.constraints_dir,
+ template_dir=processed.template_dir,
+ extra_mols_dir=processed.extra_mols_dir,
+ override_method="other",
+ affinity=True,
+ )
+
+ predict_affinity_args = {
+ "recycling_steps": 5,
+ "sampling_steps": sampling_steps_affinity,
+ "diffusion_samples": diffusion_samples_affinity,
+ "max_parallel_samples": 1,
+ "write_confidence_summary": False,
+ "write_full_pae": False,
+ "write_full_pde": False,
+ }
+
+ # Load affinity model
+ if affinity_checkpoint is None:
+ affinity_checkpoint = cache / "boltz2_aff.ckpt"
+
+ steering_args = BoltzSteeringParams()
+ steering_args.fk_steering = False
+ steering_args.physical_guidance_update = False
+ steering_args.contact_guidance_update = False
+
+ model_module = Boltz2.load_from_checkpoint(
+ affinity_checkpoint,
+ strict=True,
+ predict_args=predict_affinity_args,
+ map_location="cpu",
+ diffusion_process_args=asdict(diffusion_params),
+ ema=False,
+ pairformer_args=asdict(pairformer_args),
+ msa_args=asdict(msa_args),
+ steering_args=asdict(steering_args),
+ affinity_mw_correction=affinity_mw_correction,
+ )
+ model_module.eval()
+
+ trainer.callbacks[0] = pred_writer
+ trainer.predict(
+ model_module,
+ datamodule=data_module,
+ return_predictions=False,
+ )
+
+
+if __name__ == "__main__":
+ cli()
diff --git a/forks/boltz/src/boltz/model/__init__.py b/forks/boltz/src/boltz/model/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/model/layers/__init__.py b/forks/boltz/src/boltz/model/layers/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/model/layers/attention.py b/forks/boltz/src/boltz/model/layers/attention.py
new file mode 100644
index 00000000..2eb0cd3b
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/attention.py
@@ -0,0 +1,132 @@
+import torch
+from einops.layers.torch import Rearrange
+from torch import Tensor, nn
+
+import boltz.model.layers.initialize as init
+
+
+class AttentionPairBias(nn.Module):
+ """Attention pair bias layer."""
+
+ def __init__(
+ self,
+ c_s: int,
+ c_z: int,
+ num_heads: int,
+ inf: float = 1e6,
+ initial_norm: bool = True,
+ ) -> None:
+ """Initialize the attention pair bias layer.
+
+ Parameters
+ ----------
+ c_s : int
+ The input sequence dimension.
+ c_z : int
+ The input pairwise dimension.
+ num_heads : int
+ The number of heads.
+ inf : float, optional
+ The inf value, by default 1e6
+ initial_norm: bool, optional
+ Whether to apply layer norm to the input, by default True
+
+ """
+ super().__init__()
+
+ assert c_s % num_heads == 0
+
+ self.c_s = c_s
+ self.num_heads = num_heads
+ self.head_dim = c_s // num_heads
+ self.inf = inf
+
+ self.initial_norm = initial_norm
+ if self.initial_norm:
+ self.norm_s = nn.LayerNorm(c_s)
+
+ self.proj_q = nn.Linear(c_s, c_s)
+ self.proj_k = nn.Linear(c_s, c_s, bias=False)
+ self.proj_v = nn.Linear(c_s, c_s, bias=False)
+ self.proj_g = nn.Linear(c_s, c_s, bias=False)
+
+ self.proj_z = nn.Sequential(
+ nn.LayerNorm(c_z),
+ nn.Linear(c_z, num_heads, bias=False),
+ Rearrange("b ... h -> b h ..."),
+ )
+
+ self.proj_o = nn.Linear(c_s, c_s, bias=False)
+ init.final_init_(self.proj_o.weight)
+
+ def forward(
+ self,
+ s: Tensor,
+ z: Tensor,
+ mask: Tensor,
+ multiplicity: int = 1,
+ to_keys=None,
+ model_cache=None,
+ ) -> Tensor:
+ """Forward pass.
+
+ Parameters
+ ----------
+ s : torch.Tensor
+ The input sequence tensor (B, S, D)
+ z : torch.Tensor
+ The input pairwise tensor (B, N, N, D)
+ mask : torch.Tensor
+ The pairwise mask tensor (B, N)
+ multiplicity : int, optional
+ The diffusion batch size, by default 1
+
+ Returns
+ -------
+ torch.Tensor
+ The output sequence tensor.
+
+ """
+ B = s.shape[0]
+
+ # Layer norms
+ if self.initial_norm:
+ s = self.norm_s(s)
+
+ if to_keys is not None:
+ k_in = to_keys(s)
+ mask = to_keys(mask.unsqueeze(-1)).squeeze(-1)
+ else:
+ k_in = s
+
+ # Compute projections
+ q = self.proj_q(s).view(B, -1, self.num_heads, self.head_dim)
+ k = self.proj_k(k_in).view(B, -1, self.num_heads, self.head_dim)
+ v = self.proj_v(k_in).view(B, -1, self.num_heads, self.head_dim)
+
+ # Caching z projection during diffusion roll-out
+ if model_cache is None or "z" not in model_cache:
+ z = self.proj_z(z)
+
+ if model_cache is not None:
+ model_cache["z"] = z
+ else:
+ z = model_cache["z"]
+ z = z.repeat_interleave(multiplicity, 0)
+
+ g = self.proj_g(s).sigmoid()
+
+ with torch.autocast("cuda", enabled=False):
+ # Compute attention weights
+ attn = torch.einsum("bihd,bjhd->bhij", q.float(), k.float())
+ attn = attn / (self.head_dim**0.5) + z.float()
+ # The pairwise mask tensor (B, N) is broadcasted to (B, 1, 1, N) and (B, H, N, N)
+ attn = attn + (1 - mask[:, None, None].float()) * -self.inf
+ attn = attn.softmax(dim=-1)
+
+ # Compute output
+ o = torch.einsum("bhij,bjhd->bihd", attn, v.float()).to(v.dtype)
+ o = o.reshape(B, -1, self.c_s)
+ o = self.proj_o(g * o)
+
+ return o
diff --git a/forks/boltz/src/boltz/model/layers/attentionv2.py b/forks/boltz/src/boltz/model/layers/attentionv2.py
new file mode 100644
index 00000000..6381f69f
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/attentionv2.py
@@ -0,0 +1,111 @@
+from typing import Optional
+
+import torch
+from einops.layers.torch import Rearrange
+from torch import Tensor, nn
+
+import boltz.model.layers.initialize as init
+
+
+class AttentionPairBias(nn.Module):
+ """Attention pair bias layer."""
+
+ def __init__(
+ self,
+ c_s: int,
+ c_z: Optional[int] = None,
+ num_heads: Optional[int] = None,
+ inf: float = 1e6,
+ compute_pair_bias: bool = True,
+ ) -> None:
+ """Initialize the attention pair bias layer.
+
+ Parameters
+ ----------
+ c_s : int
+ The input sequence dimension.
+ c_z : int
+ The input pairwise dimension.
+ num_heads : int
+ The number of heads.
+ inf : float, optional
+ The inf value, by default 1e6
+
+ """
+ super().__init__()
+
+ assert c_s % num_heads == 0
+
+ self.c_s = c_s
+ self.num_heads = num_heads
+ self.head_dim = c_s // num_heads
+ self.inf = inf
+
+ self.proj_q = nn.Linear(c_s, c_s)
+ self.proj_k = nn.Linear(c_s, c_s, bias=False)
+ self.proj_v = nn.Linear(c_s, c_s, bias=False)
+ self.proj_g = nn.Linear(c_s, c_s, bias=False)
+
+ self.compute_pair_bias = compute_pair_bias
+ if compute_pair_bias:
+ self.proj_z = nn.Sequential(
+ nn.LayerNorm(c_z),
+ nn.Linear(c_z, num_heads, bias=False),
+ Rearrange("b ... h -> b h ..."),
+ )
+ else:
+ self.proj_z = Rearrange("b ... h -> b h ...")
+
+ self.proj_o = nn.Linear(c_s, c_s, bias=False)
+ init.final_init_(self.proj_o.weight)
+
+ def forward(
+ self,
+ s: Tensor,
+ z: Tensor,
+ mask: Tensor,
+ k_in: Tensor,
+ multiplicity: int = 1,
+ ) -> Tensor:
+ """Forward pass.
+
+ Parameters
+ ----------
+ s : torch.Tensor
+ The input sequence tensor (B, S, D)
+ z : torch.Tensor
+ The input pairwise tensor or bias (B, N, N, D)
+ mask : torch.Tensor
+ The pairwise mask tensor (B, N, N)
+
+ Returns
+ -------
+ torch.Tensor
+ The output sequence tensor.
+
+ """
+ B = s.shape[0]
+
+ # Compute projections
+ q = self.proj_q(s).view(B, -1, self.num_heads, self.head_dim)
+ k = self.proj_k(k_in).view(B, -1, self.num_heads, self.head_dim)
+ v = self.proj_v(k_in).view(B, -1, self.num_heads, self.head_dim)
+
+ bias = self.proj_z(z)
+ bias = bias.repeat_interleave(multiplicity, 0)
+
+ g = self.proj_g(s).sigmoid()
+
+ with torch.autocast("cuda", enabled=False):
+ # Compute attention weights
+ attn = torch.einsum("bihd,bjhd->bhij", q.float(), k.float())
+ attn = attn / (self.head_dim**0.5) + bias.float()
+ attn = attn + (1 - mask[:, None, None].float()) * -self.inf
+ attn = attn.softmax(dim=-1)
+
+ # Compute output
+ o = torch.einsum("bhij,bjhd->bihd", attn, v.float()).to(v.dtype)
+ o = o.reshape(B, -1, self.c_s)
+ o = self.proj_o(g * o)
+
+ return o
diff --git a/forks/boltz/src/boltz/model/layers/confidence_utils.py b/forks/boltz/src/boltz/model/layers/confidence_utils.py
new file mode 100644
index 00000000..de9eb50e
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/confidence_utils.py
@@ -0,0 +1,231 @@
+import torch
+from torch import nn
+
+from boltz.data import const
+
+
+def compute_collinear_mask(v1, v2):
+ norm1 = torch.norm(v1, dim=1, keepdim=True)
+ norm2 = torch.norm(v2, dim=1, keepdim=True)
+ v1 = v1 / (norm1 + 1e-6)
+ v2 = v2 / (norm2 + 1e-6)
+ mask_angle = torch.abs(torch.sum(v1 * v2, dim=1)) < 0.9063
+ mask_overlap1 = norm1.reshape(-1) > 1e-2
+ mask_overlap2 = norm2.reshape(-1) > 1e-2
+ return mask_angle & mask_overlap1 & mask_overlap2
+
+
+def compute_frame_pred(
+ pred_atom_coords,
+ frames_idx_true,
+ feats,
+ multiplicity,
+ resolved_mask=None,
+ inference=False,
+):
+ with torch.amp.autocast("cuda", enabled=False):
+ asym_id_token = feats["asym_id"]
+ asym_id_atom = torch.bmm(
+ feats["atom_to_token"].float(), asym_id_token.unsqueeze(-1).float()
+ ).squeeze(-1)
+
+ B, N, _ = pred_atom_coords.shape
+ pred_atom_coords = pred_atom_coords.reshape(B // multiplicity, multiplicity, -1, 3)
+ frames_idx_pred = (
+ frames_idx_true.clone()
+ .repeat_interleave(multiplicity, 0)
+ .reshape(B // multiplicity, multiplicity, -1, 3)
+ )
+
+ # Iterate through the batch and modify the frames for nonpolymers
+ for i, pred_atom_coord in enumerate(pred_atom_coords):
+ token_idx = 0
+ atom_idx = 0
+ for id in torch.unique(asym_id_token[i]):
+ mask_chain_token = (asym_id_token[i] == id) * feats["token_pad_mask"][i]
+ mask_chain_atom = (asym_id_atom[i] == id) * feats["atom_pad_mask"][i]
+ num_tokens = int(mask_chain_token.sum().item())
+ num_atoms = int(mask_chain_atom.sum().item())
+ if (
+ feats["mol_type"][i, token_idx] != const.chain_type_ids["NONPOLYMER"]
+ or num_atoms < 3
+ ):
+ token_idx += num_tokens
+ atom_idx += num_atoms
+ continue
+ dist_mat = (
+ (
+ pred_atom_coord[:, mask_chain_atom.bool()][:, None, :, :]
+ - pred_atom_coord[:, mask_chain_atom.bool()][:, :, None, :]
+ )
+ ** 2
+ ).sum(-1) ** 0.5
+ if inference:
+ resolved_pair = 1 - (
+ feats["atom_pad_mask"][i][mask_chain_atom.bool()][None, :]
+ * feats["atom_pad_mask"][i][mask_chain_atom.bool()][:, None]
+ ).to(torch.float32)
+ resolved_pair[resolved_pair == 1] = torch.inf
+ indices = torch.sort(dist_mat + resolved_pair, axis=2).indices
+ else:
+ if resolved_mask is None:
+ resolved_mask = feats["atom_resolved_mask"]
+ resolved_pair = 1 - (
+ resolved_mask[i][mask_chain_atom.bool()][None, :]
+ * resolved_mask[i][mask_chain_atom.bool()][:, None]
+ ).to(torch.float32)
+ resolved_pair[resolved_pair == 1] = torch.inf
+ indices = torch.sort(dist_mat + resolved_pair, axis=2).indices
+ frames = (
+ torch.cat(
+ [
+ indices[:, :, 1:2],
+ indices[:, :, 0:1],
+ indices[:, :, 2:3],
+ ],
+ dim=2,
+ )
+ + atom_idx
+ )
+ try:
+ frames_idx_pred[i, :, token_idx : token_idx + num_atoms, :] = frames
+ except Exception as e:
+ print(f"Failed to process {feats['pdb_id']} due to {e}")
+ token_idx += num_tokens
+ atom_idx += num_atoms
+
+ frames_expanded = pred_atom_coords[
+ torch.arange(0, B // multiplicity, 1)[:, None, None, None].to(
+ frames_idx_pred.device
+ ),
+ torch.arange(0, multiplicity, 1)[None, :, None, None].to(
+ frames_idx_pred.device
+ ),
+ frames_idx_pred,
+ ].reshape(-1, 3, 3)
+
+ # Compute masks for collinearity / overlap
+ mask_collinear_pred = compute_collinear_mask(
+ frames_expanded[:, 1] - frames_expanded[:, 0],
+ frames_expanded[:, 1] - frames_expanded[:, 2],
+ ).reshape(B // multiplicity, multiplicity, -1)
+ return frames_idx_pred, mask_collinear_pred * feats["token_pad_mask"][:, None, :]
+
+
+def compute_aggregated_metric(logits, end=1.0):
+ # Compute aggregated metric from logits
+ num_bins = logits.shape[-1]
+ bin_width = end / num_bins
+ bounds = torch.arange(
+ start=0.5 * bin_width, end=end, step=bin_width, device=logits.device
+ )
+ probs = nn.functional.softmax(logits, dim=-1)
+ plddt = torch.sum(
+ probs * bounds.view(*((1,) * len(probs.shape[:-1])), *bounds.shape),
+ dim=-1,
+ )
+ return plddt
+
+
+def tm_function(d, Nres):
+ d0 = 1.24 * (torch.clip(Nres, min=19) - 15) ** (1 / 3) - 1.8
+ return 1 / (1 + (d / d0) ** 2)
+
+
+def compute_ptms(logits, x_preds, feats, multiplicity):
+ # It needs to take as input the mask of the frames as they are not used to compute the PTM
+ _, mask_collinear_pred = compute_frame_pred(
+ x_preds, feats["frames_idx"], feats, multiplicity, inference=True
+ )
+ # mask overlapping, collinear tokens and ions (invalid frames)
+ mask_pad = feats["token_pad_mask"].repeat_interleave(multiplicity, 0)
+ maski = mask_collinear_pred.reshape(-1, mask_collinear_pred.shape[-1])
+ pair_mask_ptm = maski[:, :, None] * mask_pad[:, None, :] * mask_pad[:, :, None]
+ asym_id = feats["asym_id"].repeat_interleave(multiplicity, 0)
+ pair_mask_iptm = (
+ maski[:, :, None]
+ * (asym_id[:, None, :] != asym_id[:, :, None])
+ * mask_pad[:, None, :]
+ * mask_pad[:, :, None]
+ )
+ num_bins = logits.shape[-1]
+ bin_width = 32.0 / num_bins
+ end = 32.0
+ pae_value = torch.arange(
+ start=0.5 * bin_width, end=end, step=bin_width, device=logits.device
+ ).unsqueeze(0)
+ N_res = mask_pad.sum(dim=-1, keepdim=True)
+ tm_value = tm_function(pae_value, N_res).unsqueeze(1).unsqueeze(2)
+ probs = nn.functional.softmax(logits, dim=-1)
+ tm_expected_value = torch.sum(
+ probs * tm_value,
+ dim=-1,
+ ) # shape (B, N, N)
+ ptm = torch.max(
+ torch.sum(tm_expected_value * pair_mask_ptm, dim=-1)
+ / (torch.sum(pair_mask_ptm, dim=-1) + 1e-5),
+ dim=1,
+ ).values
+ iptm = torch.max(
+ torch.sum(tm_expected_value * pair_mask_iptm, dim=-1)
+ / (torch.sum(pair_mask_iptm, dim=-1) + 1e-5),
+ dim=1,
+ ).values
+
+ # compute ligand and protein iPTM
+ token_type = feats["mol_type"]
+ token_type = token_type.repeat_interleave(multiplicity, 0)
+ is_ligand_token = (token_type == const.chain_type_ids["NONPOLYMER"]).float()
+ is_protein_token = (token_type == const.chain_type_ids["PROTEIN"]).float()
+
+ ligand_iptm_mask = (
+ maski[:, :, None]
+ * (asym_id[:, None, :] != asym_id[:, :, None])
+ * mask_pad[:, None, :]
+ * mask_pad[:, :, None]
+ * (
+ (is_ligand_token[:, :, None] * is_protein_token[:, None, :])
+ + (is_protein_token[:, :, None] * is_ligand_token[:, None, :])
+ )
+ )
+ protein_ipmt_mask = (
+ maski[:, :, None]
+ * (asym_id[:, None, :] != asym_id[:, :, None])
+ * mask_pad[:, None, :]
+ * mask_pad[:, :, None]
+ * (is_protein_token[:, :, None] * is_protein_token[:, None, :])
+ )
+
+ ligand_iptm = torch.max(
+ torch.sum(tm_expected_value * ligand_iptm_mask, dim=-1)
+ / (torch.sum(ligand_iptm_mask, dim=-1) + 1e-5),
+ dim=1,
+ ).values
+ protein_iptm = torch.max(
+ torch.sum(tm_expected_value * protein_ipmt_mask, dim=-1)
+ / (torch.sum(protein_ipmt_mask, dim=-1) + 1e-5),
+ dim=1,
+ ).values
+
+ # Compute pair chain ipTM
+ chain_pair_iptm = {}
+ asym_ids_list = torch.unique(asym_id).tolist()
+ for idx1 in asym_ids_list:
+ chain_iptm = {}
+ for idx2 in asym_ids_list:
+ mask_pair_chain = (
+ maski[:, :, None]
+ * (asym_id[:, None, :] == idx1)
+ * (asym_id[:, :, None] == idx2)
+ * mask_pad[:, None, :]
+ * mask_pad[:, :, None]
+ )
+
+ chain_iptm[idx2] = torch.max(
+ torch.sum(tm_expected_value * mask_pair_chain, dim=-1)
+ / (torch.sum(mask_pair_chain, dim=-1) + 1e-5),
+ dim=1,
+ ).values
+ chain_pair_iptm[idx1] = chain_iptm
+
+ return ptm, iptm, ligand_iptm, protein_iptm, chain_pair_iptm
diff --git a/forks/boltz/src/boltz/model/layers/dropout.py b/forks/boltz/src/boltz/model/layers/dropout.py
new file mode 100644
index 00000000..f417c863
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/dropout.py
@@ -0,0 +1,34 @@
+import torch
+from torch import Tensor
+
+
+def get_dropout_mask(
+ dropout: float,
+ z: Tensor,
+ training: bool,
+ columnwise: bool = False,
+) -> Tensor:
+ """Get the dropout mask.
+
+ Parameters
+ ----------
+ dropout : float
+ The dropout rate
+ z : torch.Tensor
+ The tensor to apply dropout to
+ training : bool
+ Whether the model is in training mode
+ columnwise : bool, optional
+ Whether to apply dropout columnwise
+
+ Returns
+ -------
+ torch.Tensor
+ The dropout mask
+
+ """
+ dropout = dropout * training
+ v = z[:, 0:1, :, 0:1] if columnwise else z[:, :, 0:1, 0:1]
+ d = torch.rand_like(v) > dropout
+ d = d * 1.0 / (1.0 - dropout)
+ return d
diff --git a/forks/boltz/src/boltz/model/layers/initialize.py b/forks/boltz/src/boltz/model/layers/initialize.py
new file mode 100644
index 00000000..ace4a302
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/initialize.py
@@ -0,0 +1,100 @@
+"""Utility functions for initializing weights and biases."""
+
+# Copyright 2021 AlQuraishi Laboratory
+# Copyright 2021 DeepMind Technologies Limited
+#
+# Licensed under the Apache License, Version 2.0 (the "License");
+# you may not use this file except in compliance with the License.
+# You may obtain a copy of the License at
+#
+# http://www.apache.org/licenses/LICENSE-2.0
+#
+# Unless required by applicable law or agreed to in writing, software
+# distributed under the License is distributed on an "AS IS" BASIS,
+# WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied.
+# See the License for the specific language governing permissions and
+# limitations under the License.
+
+import math
+
+import numpy as np
+import torch
+from scipy.stats import truncnorm
+
+
+def _prod(nums):
+ out = 1
+ for n in nums:
+ out = out * n
+ return out
+
+
+def _calculate_fan(linear_weight_shape, fan="fan_in"):
+ fan_out, fan_in = linear_weight_shape
+
+ if fan == "fan_in":
+ f = fan_in
+ elif fan == "fan_out":
+ f = fan_out
+ elif fan == "fan_avg":
+ f = (fan_in + fan_out) / 2
+ else:
+ raise ValueError("Invalid fan option")
+
+ return f
+
+
+def trunc_normal_init_(weights, scale=1.0, fan="fan_in"):
+ shape = weights.shape
+ f = _calculate_fan(shape, fan)
+ scale = scale / max(1, f)
+ a = -2
+ b = 2
+ std = math.sqrt(scale) / truncnorm.std(a=a, b=b, loc=0, scale=1)
+ size = _prod(shape)
+ samples = truncnorm.rvs(a=a, b=b, loc=0, scale=std, size=size)
+ samples = np.reshape(samples, shape)
+ with torch.no_grad():
+ weights.copy_(torch.tensor(samples, device=weights.device))
+
+
+def lecun_normal_init_(weights):
+ trunc_normal_init_(weights, scale=1.0)
+
+
+def he_normal_init_(weights):
+ trunc_normal_init_(weights, scale=2.0)
+
+
+def glorot_uniform_init_(weights):
+ torch.nn.init.xavier_uniform_(weights, gain=1)
+
+
+def final_init_(weights):
+ with torch.no_grad():
+ weights.fill_(0.0)
+
+
+def gating_init_(weights):
+ with torch.no_grad():
+ weights.fill_(0.0)
+
+
+def bias_init_zero_(bias):
+ with torch.no_grad():
+ bias.fill_(0.0)
+
+
+def bias_init_one_(bias):
+ with torch.no_grad():
+ bias.fill_(1.0)
+
+
+def normal_init_(weights):
+ torch.nn.init.kaiming_normal_(weights, nonlinearity="linear")
+
+
+def ipa_point_weights_init_(weights):
+ with torch.no_grad():
+ softplus_inverse_1 = 0.541324854612918
+ weights.fill_(softplus_inverse_1)
diff --git a/forks/boltz/src/boltz/model/layers/outer_product_mean.py b/forks/boltz/src/boltz/model/layers/outer_product_mean.py
new file mode 100644
index 00000000..9a4a607d
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/outer_product_mean.py
@@ -0,0 +1,98 @@
+import torch
+from torch import Tensor, nn
+
+import boltz.model.layers.initialize as init
+
+
+class OuterProductMean(nn.Module):
+ """Outer product mean layer."""
+
+ def __init__(self, c_in: int, c_hidden: int, c_out: int) -> None:
+ """Initialize the outer product mean layer.
+
+ Parameters
+ ----------
+ c_in : int
+ The input dimension.
+ c_hidden : int
+ The hidden dimension.
+ c_out : int
+ The output dimension.
+
+ """
+ super().__init__()
+ self.c_hidden = c_hidden
+ self.norm = nn.LayerNorm(c_in)
+ self.proj_a = nn.Linear(c_in, c_hidden, bias=False)
+ self.proj_b = nn.Linear(c_in, c_hidden, bias=False)
+ self.proj_o = nn.Linear(c_hidden * c_hidden, c_out)
+ init.final_init_(self.proj_o.weight)
+ init.final_init_(self.proj_o.bias)
+
+ def forward(self, m: Tensor, mask: Tensor, chunk_size: int = None) -> Tensor:
+ """Forward pass.
+
+ Parameters
+ ----------
+ m : torch.Tensor
+ The sequence tensor (B, S, N, c_in).
+ mask : torch.Tensor
+ The mask tensor (B, S, N).
+
+ Returns
+ -------
+ torch.Tensor
+ The output tensor (B, N, N, c_out).
+
+ """
+ # Expand mask
+ mask = mask.unsqueeze(-1).to(m)
+
+ # Compute projections
+ m = self.norm(m)
+ a = self.proj_a(m) * mask
+ b = self.proj_b(m) * mask
+
+ # Compute outer product mean
+ if chunk_size is not None and not self.training:
+ # Compute pairwise mask
+ for i in range(0, mask.shape[1], 64):
+ if i == 0:
+ num_mask = (
+ mask[:, i : i + 64, None, :] * mask[:, i : i + 64, :, None]
+ ).sum(1)
+ else:
+ num_mask += (
+ mask[:, i : i + 64, None, :] * mask[:, i : i + 64, :, None]
+ ).sum(1)
+ num_mask = num_mask.clamp(min=1)
+
+ # Compute squentially in chunks
+ for i in range(0, self.c_hidden, chunk_size):
+ a_chunk = a[:, :, :, i : i + chunk_size]
+ sliced_weight_proj_o = self.proj_o.weight[
+ :, i * self.c_hidden : (i + chunk_size) * self.c_hidden
+ ]
+
+ z = torch.einsum("bsic,bsjd->bijcd", a_chunk, b)
+ z = z.reshape(*z.shape[:3], -1)
+ z = z / num_mask
+
+ # Project to output
+ if i == 0:
+ z_out = z.to(m) @ sliced_weight_proj_o.T
+ else:
+ z_out = z_out + z.to(m) @ sliced_weight_proj_o.T
+
+ z_out = z_out + self.proj_o.bias # add bias
+ return z_out
+ else:
+ mask = mask[:, :, None, :] * mask[:, :, :, None]
+ num_mask = mask.sum(1).clamp(min=1)
+ z = torch.einsum("bsic,bsjd->bijcd", a.float(), b.float())
+ z = z.reshape(*z.shape[:3], -1)
+ z = z / num_mask
+
+ # Project to output
+ z = self.proj_o(z.to(m))
+ return z
diff --git a/forks/boltz/src/boltz/model/layers/pair_averaging.py b/forks/boltz/src/boltz/model/layers/pair_averaging.py
new file mode 100644
index 00000000..c0a2d5e4
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/pair_averaging.py
@@ -0,0 +1,135 @@
+import torch
+from torch import Tensor, nn
+
+import boltz.model.layers.initialize as init
+
+
+class PairWeightedAveraging(nn.Module):
+ """Pair weighted averaging layer."""
+
+ def __init__(
+ self,
+ c_m: int,
+ c_z: int,
+ c_h: int,
+ num_heads: int,
+ inf: float = 1e6,
+ ) -> None:
+ """Initialize the pair weighted averaging layer.
+
+ Parameters
+ ----------
+ c_m: int
+ The dimension of the input sequence.
+ c_z: int
+ The dimension of the input pairwise tensor.
+ c_h: int
+ The dimension of the hidden.
+ num_heads: int
+ The number of heads.
+ inf: float
+ The value to use for masking, default 1e6.
+
+ """
+ super().__init__()
+ self.c_m = c_m
+ self.c_z = c_z
+ self.c_h = c_h
+ self.num_heads = num_heads
+ self.inf = inf
+
+ self.norm_m = nn.LayerNorm(c_m)
+ self.norm_z = nn.LayerNorm(c_z)
+
+ self.proj_m = nn.Linear(c_m, c_h * num_heads, bias=False)
+ self.proj_g = nn.Linear(c_m, c_h * num_heads, bias=False)
+ self.proj_z = nn.Linear(c_z, num_heads, bias=False)
+ self.proj_o = nn.Linear(c_h * num_heads, c_m, bias=False)
+ init.final_init_(self.proj_o.weight)
+
+ def forward(
+ self, m: Tensor, z: Tensor, mask: Tensor, chunk_heads: False = bool
+ ) -> Tensor:
+ """Forward pass.
+
+ Parameters
+ ----------
+ m : torch.Tensor
+ The input sequence tensor (B, S, N, D)
+ z : torch.Tensor
+ The input pairwise tensor (B, N, N, D)
+ mask : torch.Tensor
+ The pairwise mask tensor (B, N, N)
+
+ Returns
+ -------
+ torch.Tensor
+ The output sequence tensor (B, S, N, D)
+
+ """
+ # Compute layer norms
+ m = self.norm_m(m)
+ z = self.norm_z(z)
+
+ if chunk_heads and not self.training:
+ # Compute heads sequentially
+ o_chunks = []
+ for head_idx in range(self.num_heads):
+ sliced_weight_proj_m = self.proj_m.weight[
+ head_idx * self.c_h : (head_idx + 1) * self.c_h, :
+ ]
+ sliced_weight_proj_g = self.proj_g.weight[
+ head_idx * self.c_h : (head_idx + 1) * self.c_h, :
+ ]
+ sliced_weight_proj_z = self.proj_z.weight[head_idx : (head_idx + 1), :]
+ sliced_weight_proj_o = self.proj_o.weight[
+ :, head_idx * self.c_h : (head_idx + 1) * self.c_h
+ ]
+
+ # Project input tensors
+ v: Tensor = m @ sliced_weight_proj_m.T
+ v = v.reshape(*v.shape[:3], 1, self.c_h)
+ v = v.permute(0, 3, 1, 2, 4)
+
+ # Compute weights
+ b: Tensor = z @ sliced_weight_proj_z.T
+ b = b.permute(0, 3, 1, 2)
+ b = b + (1 - mask[:, None]) * -self.inf
+ w = torch.softmax(b, dim=-1)
+
+ # Compute gating
+ g: Tensor = m @ sliced_weight_proj_g.T
+ g = g.sigmoid()
+
+ # Compute output
+ o = torch.einsum("bhij,bhsjd->bhsid", w, v)
+ o = o.permute(0, 2, 3, 1, 4)
+ o = o.reshape(*o.shape[:3], 1 * self.c_h)
+ o_chunks = g * o
+ if head_idx == 0:
+ o_out = o_chunks @ sliced_weight_proj_o.T
+ else:
+ o_out += o_chunks @ sliced_weight_proj_o.T
+ return o_out
+ else:
+ # Project input tensors
+ v: Tensor = self.proj_m(m)
+ v = v.reshape(*v.shape[:3], self.num_heads, self.c_h)
+ v = v.permute(0, 3, 1, 2, 4)
+
+ # Compute weights
+ b: Tensor = self.proj_z(z)
+ b = b.permute(0, 3, 1, 2)
+ b = b + (1 - mask[:, None]) * -self.inf
+ w = torch.softmax(b, dim=-1)
+
+ # Compute gating
+ g: Tensor = self.proj_g(m)
+ g = g.sigmoid()
+
+ # Compute output
+ o = torch.einsum("bhij,bhsjd->bhsid", w, v)
+ o = o.permute(0, 2, 3, 1, 4)
+ o = o.reshape(*o.shape[:3], self.num_heads * self.c_h)
+ o = self.proj_o(g * o)
+ return o
diff --git a/forks/boltz/src/boltz/model/layers/pairformer.py b/forks/boltz/src/boltz/model/layers/pairformer.py
new file mode 100644
index 00000000..7edadbfe
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/pairformer.py
@@ -0,0 +1,335 @@
+from typing import Optional
+
+import torch
+from torch import Tensor, nn
+
+from boltz.data import const
+from boltz.model.layers.attention import AttentionPairBias
+from boltz.model.layers.attentionv2 import AttentionPairBias as AttentionPairBiasV2
+from boltz.model.layers.dropout import get_dropout_mask
+from boltz.model.layers.transition import Transition
+from boltz.model.layers.triangular_attention.attention import (
+ TriangleAttentionEndingNode,
+ TriangleAttentionStartingNode,
+)
+from boltz.model.layers.triangular_mult import (
+ TriangleMultiplicationIncoming,
+ TriangleMultiplicationOutgoing,
+)
+
+
+class PairformerLayer(nn.Module):
+ """Pairformer module."""
+
+ def __init__(
+ self,
+ token_s: int,
+ token_z: int,
+ num_heads: int = 16,
+ dropout: float = 0.25,
+ pairwise_head_width: int = 32,
+ pairwise_num_heads: int = 4,
+ post_layer_norm: bool = False,
+ v2: bool = False,
+ ) -> None:
+ super().__init__()
+ self.token_z = token_z
+ self.dropout = dropout
+ self.num_heads = num_heads
+ self.post_layer_norm = post_layer_norm
+
+ self.pre_norm_s = nn.LayerNorm(token_s)
+ if v2:
+ self.attention = AttentionPairBiasV2(token_s, token_z, num_heads)
+ else:
+ self.attention = AttentionPairBias(token_s, token_z, num_heads)
+
+ self.tri_mul_out = TriangleMultiplicationOutgoing(token_z)
+ self.tri_mul_in = TriangleMultiplicationIncoming(token_z)
+
+ self.tri_att_start = TriangleAttentionStartingNode(
+ token_z, pairwise_head_width, pairwise_num_heads, inf=1e9
+ )
+ self.tri_att_end = TriangleAttentionEndingNode(
+ token_z, pairwise_head_width, pairwise_num_heads, inf=1e9
+ )
+
+ self.transition_s = Transition(token_s, token_s * 4)
+ self.transition_z = Transition(token_z, token_z * 4)
+
+ self.s_post_norm = (
+ nn.LayerNorm(token_s) if self.post_layer_norm else nn.Identity()
+ )
+
+ def forward(
+ self,
+ s: Tensor,
+ z: Tensor,
+ mask: Tensor,
+ pair_mask: Tensor,
+ chunk_size_tri_attn: Optional[int] = None,
+ use_kernels: bool = False,
+ use_cuequiv_mul: bool = False,
+ use_cuequiv_attn: bool = False,
+ ) -> tuple[Tensor, Tensor]:
+ # Compute pairwise stack
+ dropout = get_dropout_mask(self.dropout, z, self.training)
+ z = z + dropout * self.tri_mul_out(
+ z, mask=pair_mask, use_kernels=use_cuequiv_mul or use_kernels
+ )
+
+ dropout = get_dropout_mask(self.dropout, z, self.training)
+ z = z + dropout * self.tri_mul_in(
+ z, mask=pair_mask, use_kernels=use_cuequiv_mul or use_kernels
+ )
+
+ dropout = get_dropout_mask(self.dropout, z, self.training)
+ z = z + dropout * self.tri_att_start(
+ z,
+ mask=pair_mask,
+ chunk_size=chunk_size_tri_attn,
+ use_kernels=use_cuequiv_attn or use_kernels,
+ )
+
+ dropout = get_dropout_mask(self.dropout, z, self.training, columnwise=True)
+ z = z + dropout * self.tri_att_end(
+ z,
+ mask=pair_mask,
+ chunk_size=chunk_size_tri_attn,
+ use_kernels=use_cuequiv_attn or use_kernels,
+ )
+
+ z = z + self.transition_z(z)
+
+ # Compute sequence stack
+ with torch.autocast("cuda", enabled=False):
+ s_normed = self.pre_norm_s(s.float())
+ s = s.float() + self.attention(
+ s=s_normed, z=z.float(), mask=mask.float(), k_in=s_normed
+ )
+ s = s + self.transition_s(s)
+ s = self.s_post_norm(s)
+
+ return s, z
+
+
+class PairformerModule(nn.Module):
+ """Pairformer module."""
+
+ def __init__(
+ self,
+ token_s: int,
+ token_z: int,
+ num_blocks: int,
+ num_heads: int = 16,
+ dropout: float = 0.25,
+ pairwise_head_width: int = 32,
+ pairwise_num_heads: int = 4,
+ post_layer_norm: bool = False,
+ activation_checkpointing: bool = False,
+ v2: bool = False,
+ **kwargs,
+ ) -> None:
+ super().__init__()
+ self.token_z = token_z
+ self.num_blocks = num_blocks
+ self.dropout = dropout
+ self.num_heads = num_heads
+ self.post_layer_norm = post_layer_norm
+ self.activation_checkpointing = activation_checkpointing
+
+ self.layers = nn.ModuleList()
+ for _ in range(num_blocks):
+ self.layers.append(
+ PairformerLayer(
+ token_s,
+ token_z,
+ num_heads,
+ dropout,
+ pairwise_head_width,
+ pairwise_num_heads,
+ post_layer_norm,
+ v2,
+ ),
+ )
+
+ def forward(
+ self,
+ s: Tensor,
+ z: Tensor,
+ mask: Tensor,
+ pair_mask: Tensor,
+ use_kernels: bool = False,
+ ) -> tuple[Tensor, Tensor]:
+ """Perform the forward pass.
+
+ Parameters
+ ----------
+ s : Tensor
+ The sequence stack.
+ z : Tensor
+ The pairwise stack.
+ mask : Tensor
+ The mask.
+ pair_mask : Tensor
+ The pairwise mask.
+ use_kernels : bool
+ Whether to use kernels.
+
+ """
+ if not self.training:
+ if z.shape[1] > const.chunk_size_threshold:
+ chunk_size_tri_attn = 128
+ else:
+ chunk_size_tri_attn = 512
+ else:
+ chunk_size_tri_attn = None
+
+ for layer in self.layers:
+ if self.activation_checkpointing and self.training:
+ s, z = torch.utils.checkpoint.checkpoint(
+ layer,
+ s,
+ z,
+ mask,
+ pair_mask,
+ chunk_size_tri_attn,
+ use_kernels,
+ )
+ else:
+ s, z = layer(s, z, mask, pair_mask, chunk_size_tri_attn, use_kernels)
+ return s, z
+
+
+class PairformerNoSeqLayer(nn.Module):
+ """Pairformer module without sequence track."""
+
+ def __init__(
+ self,
+ token_z: int,
+ dropout: float = 0.25,
+ pairwise_head_width: int = 32,
+ pairwise_num_heads: int = 4,
+ post_layer_norm: bool = False,
+ ) -> None:
+ super().__init__()
+ self.token_z = token_z
+ self.dropout = dropout
+ self.post_layer_norm = post_layer_norm
+
+ self.tri_mul_out = TriangleMultiplicationOutgoing(token_z)
+ self.tri_mul_in = TriangleMultiplicationIncoming(token_z)
+
+ self.tri_att_start = TriangleAttentionStartingNode(
+ token_z, pairwise_head_width, pairwise_num_heads, inf=1e9
+ )
+ self.tri_att_end = TriangleAttentionEndingNode(
+ token_z, pairwise_head_width, pairwise_num_heads, inf=1e9
+ )
+
+ self.transition_z = Transition(token_z, token_z * 4)
+
+ def forward(
+ self,
+ z: Tensor,
+ pair_mask: Tensor,
+ chunk_size_tri_attn: Optional[int] = None,
+ use_kernels: bool = False,
+ use_cuequiv_mul: bool = False,
+ use_cuequiv_attn: bool = False,
+ ) -> Tensor:
+ # Compute pairwise stack
+ dropout = get_dropout_mask(self.dropout, z, self.training)
+ z = z + dropout * self.tri_mul_out(
+ z, mask=pair_mask, use_kernels=use_cuequiv_mul or use_kernels
+ )
+
+ dropout = get_dropout_mask(self.dropout, z, self.training)
+ z = z + dropout * self.tri_mul_in(
+ z, mask=pair_mask, use_kernels=use_cuequiv_mul or use_kernels
+ )
+
+ dropout = get_dropout_mask(self.dropout, z, self.training)
+ z = z + dropout * self.tri_att_start(
+ z,
+ mask=pair_mask,
+ chunk_size=chunk_size_tri_attn,
+ use_kernels=use_cuequiv_attn or use_kernels,
+ )
+
+ dropout = get_dropout_mask(self.dropout, z, self.training, columnwise=True)
+ z = z + dropout * self.tri_att_end(
+ z,
+ mask=pair_mask,
+ chunk_size=chunk_size_tri_attn,
+ use_kernels=use_cuequiv_attn or use_kernels,
+ )
+
+ z = z + self.transition_z(z)
+ return z
+
+
+class PairformerNoSeqModule(nn.Module):
+ """Pairformer module without sequence track."""
+
+ def __init__(
+ self,
+ token_z: int,
+ num_blocks: int,
+ dropout: float = 0.25,
+ pairwise_head_width: int = 32,
+ pairwise_num_heads: int = 4,
+ post_layer_norm: bool = False,
+ activation_checkpointing: bool = False,
+ **kwargs,
+ ) -> None:
+ super().__init__()
+ self.token_z = token_z
+ self.num_blocks = num_blocks
+ self.dropout = dropout
+ self.post_layer_norm = post_layer_norm
+ self.activation_checkpointing = activation_checkpointing
+
+ self.layers = nn.ModuleList()
+ for i in range(num_blocks):
+ self.layers.append(
+ PairformerNoSeqLayer(
+ token_z,
+ dropout,
+ pairwise_head_width,
+ pairwise_num_heads,
+ post_layer_norm,
+ ),
+ )
+
+ def forward(
+ self,
+ z: Tensor,
+ pair_mask: Tensor,
+ use_kernels: bool = False,
+ ) -> Tensor:
+ if not self.training:
+ if z.shape[1] > const.chunk_size_threshold:
+ chunk_size_tri_attn = 128
+ else:
+ chunk_size_tri_attn = 512
+ else:
+ chunk_size_tri_attn = None
+
+ for layer in self.layers:
+ if self.activation_checkpointing and self.training:
+ z = torch.utils.checkpoint.checkpoint(
+ layer,
+ z,
+ pair_mask,
+ chunk_size_tri_attn,
+ use_kernels,
+ )
+ else:
+ z = layer(
+ z,
+ pair_mask,
+ chunk_size_tri_attn,
+ use_kernels,
+ )
+ return z
diff --git a/forks/boltz/src/boltz/model/layers/relative.py b/forks/boltz/src/boltz/model/layers/relative.py
new file mode 100644
index 00000000..6aec100c
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/relative.py
@@ -0,0 +1,58 @@
+import torch
+
+
+def compute_relative_distribution_perfect_correlation(
+ binned_distribution_1, binned_distribution_2
+):
+ """
+ Compute the relative distribution between two binned distributions with perfect correlation.
+
+ Parameters
+ ----------
+ binned_distribution_1 : torch.Tensor
+ The first binned distribution, shape (..., K).
+ binned_distribution_2 : torch.Tensor
+ The second binned distribution, shape (..., K).
+
+ Returns
+ -------
+ torch.Tensor
+ The relative distribution, shape (..., 2K - 1).
+
+ """
+ K = binned_distribution_1.shape[-1]
+ relative_distribution = torch.zeros(
+ binned_distribution_1.shape[:-1] + (2 * K - 1,),
+ device=binned_distribution_1.device,
+ )
+ zero = torch.zeros(
+ binned_distribution_1.shape[:-1] + (1,), device=binned_distribution_1.device
+ )
+
+ binned_distribution_1 = torch.cat([zero, binned_distribution_1], dim=-1)
+ binned_distribution_2 = torch.cat([zero, binned_distribution_2], dim=-1)
+
+ cumulative_1 = torch.cumsum(binned_distribution_1, dim=-1)
+ cumulative_2 = torch.cumsum(binned_distribution_2, dim=-1)
+
+ for i in range(K):
+ relative_distribution[..., K - 1 + i] = torch.sum(
+ torch.relu(
+ torch.minimum(
+ cumulative_1[..., 1 + i :], cumulative_2[..., 1 : K + 1 - i]
+ )
+ - torch.maximum(cumulative_1[..., i:-1], cumulative_2[..., : K - i]),
+ )
+ )
+
+ for i in range(1, K):
+ relative_distribution[..., K - 1 - i] = torch.sum(
+ torch.relu(
+ torch.minimum(
+ cumulative_2[..., 1 + i :], cumulative_1[..., 1 : K + 1 - i]
+ )
+ - torch.maximum(cumulative_2[..., i:-1], cumulative_1[..., : K - i]),
+ )
+ )
+
+ return relative_distribution
diff --git a/forks/boltz/src/boltz/model/layers/transition.py b/forks/boltz/src/boltz/model/layers/transition.py
new file mode 100644
index 00000000..8bab8093
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/transition.py
@@ -0,0 +1,78 @@
+from typing import Optional
+
+from torch import Tensor, nn
+
+import boltz.model.layers.initialize as init
+
+
+class Transition(nn.Module):
+ """Perform a two-layer MLP."""
+
+ def __init__(
+ self,
+ dim: int = 128,
+ hidden: int = 512,
+ out_dim: Optional[int] = None,
+ ) -> None:
+ """Initialize the TransitionUpdate module.
+
+ Parameters
+ ----------
+ dim: int
+ The dimension of the input, default 128
+ hidden: int
+ The dimension of the hidden, default 512
+ out_dim: Optional[int]
+ The dimension of the output, default None
+
+ """
+ super().__init__()
+ if out_dim is None:
+ out_dim = dim
+
+ self.norm = nn.LayerNorm(dim, eps=1e-5)
+ self.fc1 = nn.Linear(dim, hidden, bias=False)
+ self.fc2 = nn.Linear(dim, hidden, bias=False)
+ self.fc3 = nn.Linear(hidden, out_dim, bias=False)
+ self.silu = nn.SiLU()
+ self.hidden = hidden
+
+ init.bias_init_one_(self.norm.weight)
+ init.bias_init_zero_(self.norm.bias)
+
+ init.lecun_normal_init_(self.fc1.weight)
+ init.lecun_normal_init_(self.fc2.weight)
+ init.final_init_(self.fc3.weight)
+
+ def forward(self, x: Tensor, chunk_size: int = None) -> Tensor:
+ """Perform a forward pass.
+
+ Parameters
+ ----------
+ x: torch.Tensor
+ The input data of shape (..., D)
+
+ Returns
+ -------
+ x: torch.Tensor
+ The output data of shape (..., D)
+
+ """
+ x = self.norm(x)
+
+ if chunk_size is None or self.training:
+ x = self.silu(self.fc1(x)) * self.fc2(x)
+ x = self.fc3(x)
+ return x
+ else:
+ # Compute in chunks
+ for i in range(0, self.hidden, chunk_size):
+ fc1_slice = self.fc1.weight[i : i + chunk_size, :]
+ fc2_slice = self.fc2.weight[i : i + chunk_size, :]
+ fc3_slice = self.fc3.weight[:, i : i + chunk_size]
+ x_chunk = self.silu((x @ fc1_slice.T)) * (x @ fc2_slice.T)
+ if i == 0:
+ x_out = x_chunk @ fc3_slice.T
+ else:
+ x_out = x_out + x_chunk @ fc3_slice.T
+ return x_out
diff --git a/forks/boltz/src/boltz/model/layers/triangular_attention/__init__.py b/forks/boltz/src/boltz/model/layers/triangular_attention/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/model/layers/triangular_attention/attention.py b/forks/boltz/src/boltz/model/layers/triangular_attention/attention.py
new file mode 100644
index 00000000..458aaa07
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/triangular_attention/attention.py
@@ -0,0 +1,189 @@
+# Copyright 2021 AlQuraishi Laboratory
+# Copyright 2021 DeepMind Technologies Limited
+#
+# Licensed under the Apache License, Version 2.0 (the "License");
+# you may not use this file except in compliance with the License.
+# You may obtain a copy of the License at
+#
+# http://www.apache.org/licenses/LICENSE-2.0
+#
+# Unless required by applicable law or agreed to in writing, software
+# distributed under the License is distributed on an "AS IS" BASIS,
+# WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied.
+# See the License for the specific language governing permissions and
+# limitations under the License.
+
+from functools import partial, partialmethod
+from typing import Optional
+
+import torch
+import torch.nn as nn
+
+from boltz.model.layers.triangular_attention.primitives import (
+ Attention,
+ LayerNorm,
+ Linear,
+)
+from boltz.model.layers.triangular_attention.utils import (
+ chunk_layer,
+ permute_final_dims,
+)
+
+
+class TriangleAttention(nn.Module):
+ """Implement Algorithm 12."""
+
+ def __init__(
+ self,
+ c_in: int,
+ c_hidden: int,
+ no_heads: int,
+ starting: bool = True,
+ inf: float = 1e9,
+ ) -> None:
+ super().__init__()
+
+ self.c_in = c_in
+ self.c_hidden = c_hidden
+ self.no_heads = no_heads
+ self.starting = starting
+ self.inf = inf
+
+ self.layer_norm = LayerNorm(self.c_in)
+
+ self.linear = Linear(c_in, self.no_heads, bias=False, init="normal")
+
+ self.mha = Attention(
+ self.c_in, self.c_in, self.c_in, self.c_hidden, self.no_heads
+ )
+
+ @torch.jit.ignore
+ def _chunk(
+ self,
+ x: torch.Tensor,
+ tri_bias: torch.Tensor,
+ mask_bias: torch.Tensor,
+ mask: torch.Tensor,
+ chunk_size: int,
+ use_kernels: bool = False,
+ ) -> torch.Tensor:
+ """Compute triangle attention.
+
+ Parameters
+ ----------
+ x : torch.Tensor
+ Input tensor of shape [*, I, J, C_in]
+ biases : list[torch.Tensor]
+ List of bias tensors of shape [*, H, I, J]
+ chunk_size : int
+ Size of chunks for memory efficient computation
+ use_kernels : bool, default=False
+ Whether to use optimized CUDA kernels
+
+ Returns
+ -------
+ torch.Tensor
+ Output tensor of shape [*, I, J, C_in]
+
+ """
+ mha_inputs = {
+ "q_x": x,
+ "kv_x": x,
+ "tri_bias": tri_bias,
+ "mask_bias": mask_bias,
+ "mask": mask,
+ }
+
+ return chunk_layer(
+ partial(
+ self.mha,
+ use_kernels=use_kernels,
+ ),
+ mha_inputs,
+ chunk_size=chunk_size,
+ no_batch_dims=len(x.shape[:-2]),
+ _out=None,
+ )
+
+ def forward(
+ self,
+ x: torch.Tensor,
+ mask: Optional[torch.Tensor] = None,
+ chunk_size: Optional[int] = None,
+ use_kernels: bool = False,
+ ) -> torch.Tensor:
+ """Compute triangle attention.
+
+ Parameters
+ ----------
+ x : torch.Tensor
+ Input tensor of shape [*, I, J, C_in]
+ mask : torch.Tensor, optional
+ Attention mask of shape [*, I, J]
+ chunk_size : int, optional
+ Size of chunks for memory efficient computation
+ use_kernels : bool, default=False
+ Whether to use optimized CUDA kernels
+
+ Returns
+ -------
+ torch.Tensor
+ Output tensor of shape [*, I, J, C_in]
+
+ """
+ if mask is None:
+ # [*, I, J]
+ mask = x.new_ones(
+ x.shape[:-1],
+ )
+
+ if not self.starting:
+ x = x.transpose(-2, -3)
+ mask = mask.transpose(-1, -2)
+
+ # [*, I, J, C_in]
+ x = self.layer_norm(x)
+
+ # [*, I, 1, 1, J]
+ mask = mask[..., :, None, None, :]
+ mask_bias = self.inf * (mask - 1)
+
+ # [*, H, I, J]
+ triangle_bias = permute_final_dims(self.linear(x), (2, 0, 1))
+
+ # [*, 1, H, I, J]
+ triangle_bias = triangle_bias.unsqueeze(-4)
+
+ if chunk_size is not None and not use_kernels:
+ x = self._chunk(
+ x,
+ triangle_bias,
+ mask_bias,
+ mask,
+ chunk_size,
+ use_kernels=use_kernels,
+ )
+ else:
+ x = self.mha(
+ x,
+ x,
+ triangle_bias,
+ mask_bias,
+ mask,
+ use_kernels=use_kernels,
+ )
+
+ if not self.starting:
+ x = x.transpose(-2, -3)
+
+ return x
+
+
+# Implements Algorithm 13
+TriangleAttentionStartingNode = TriangleAttention
+
+
+class TriangleAttentionEndingNode(TriangleAttention):
+ """Implement Algorithm 14."""
+
+ __init__ = partialmethod(TriangleAttention.__init__, starting=False)
diff --git a/forks/boltz/src/boltz/model/layers/triangular_attention/primitives.py b/forks/boltz/src/boltz/model/layers/triangular_attention/primitives.py
new file mode 100644
index 00000000..26aabc7b
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/triangular_attention/primitives.py
@@ -0,0 +1,409 @@
+# Copyright 2021 AlQuraishi Laboratory
+# Copyright 2021 DeepMind Technologies Limited
+#
+# Licensed under the Apache License, Version 2.0 (the "License");
+# you may not use this file except in compliance with the License.
+# You may obtain a copy of the License at
+#
+# http://www.apache.org/licenses/LICENSE-2.0
+#
+# Unless required by applicable law or agreed to in writing, software
+# distributed under the License is distributed on an "AS IS" BASIS,
+# WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied.
+# See the License for the specific language governing permissions and
+# limitations under the License.
+
+import math
+from typing import Callable, List, Optional, Tuple
+
+import torch
+from einops import rearrange
+from torch import nn
+
+from boltz.model.layers import initialize
+from boltz.model.layers.triangular_attention.utils import (
+ flatten_final_dims,
+ permute_final_dims,
+)
+
+
+class Linear(nn.Linear):
+ """
+ A Linear layer with built-in nonstandard initializations. Called just
+ like torch.nn.Linear.
+
+ Implements the initializers in 1.11.4, plus some additional ones found
+ in the code.
+ """
+
+ def __init__(
+ self,
+ in_dim: int,
+ out_dim: int,
+ bias: bool = True,
+ init: str = "default",
+ init_fn: Optional[Callable[[torch.Tensor, torch.Tensor], None]] = None,
+ precision=None,
+ ):
+ """Initialize the linear layer.
+
+ Parameters
+ ----------
+ in_dim : int
+ The final dimension of inputs to the layer
+ out_dim : int
+ The final dimension of layer outputs
+ bias : bool, default=True
+ Whether to learn an additive bias
+ init : str, default='default'
+ The initializer to use. Choose from:
+
+ - "default": LeCun fan-in truncated normal initialization
+ - "relu": He initialization w/ truncated normal distribution
+ - "glorot": Fan-average Glorot uniform initialization
+ - "gating": Weights=0, Bias=1
+ - "normal": Normal initialization with std=1/sqrt(fan_in)
+ - "final": Weights=0, Bias=0
+
+ Overridden by init_fn if the latter is not None.
+ init_fn : callable, optional
+ A custom initializer taking weight and bias as inputs.
+ Overrides init if not None.
+
+ """
+ super().__init__(in_dim, out_dim, bias=bias)
+
+ if bias:
+ with torch.no_grad():
+ self.bias.fill_(0)
+
+ with torch.no_grad():
+ if init_fn is not None:
+ init_fn(self.weight, self.bias)
+ else:
+ if init == "default":
+ initialize.lecun_normal_init_(self.weight)
+ elif init == "relu":
+ initialize.he_normal_init_(self.weight)
+ elif init == "glorot":
+ initialize.glorot_uniform_init_(self.weight)
+ elif init == "gating":
+ initialize.gating_init_(self.weight)
+ if bias:
+ self.bias.fill_(1.0)
+ elif init == "normal":
+ initialize.normal_init_(self.weight)
+ elif init == "final":
+ initialize.final_init_(self.weight)
+ else:
+ raise ValueError("Invalid init string.")
+
+ self.precision = precision
+
+ def forward(self, input: torch.Tensor) -> torch.Tensor:
+ d = input.dtype
+ if self.precision is not None:
+ with torch.autocast("cuda", enabled=False):
+ bias = (
+ self.bias.to(dtype=self.precision)
+ if self.bias is not None
+ else None
+ )
+ return nn.functional.linear(
+ input.to(dtype=self.precision),
+ self.weight.to(dtype=self.precision),
+ bias,
+ ).to(dtype=d)
+
+ if d is torch.bfloat16:
+ with torch.autocast("cuda", enabled=False):
+ bias = self.bias.to(dtype=d) if self.bias is not None else None
+ return nn.functional.linear(input, self.weight.to(dtype=d), bias)
+
+ return nn.functional.linear(input, self.weight, self.bias)
+
+
+class LayerNorm(nn.Module):
+ def __init__(self, c_in, eps=1e-5):
+ super(LayerNorm, self).__init__()
+
+ self.c_in = (c_in,)
+ self.eps = eps
+
+ self.weight = nn.Parameter(torch.ones(c_in))
+ self.bias = nn.Parameter(torch.zeros(c_in))
+
+ def forward(self, x):
+ d = x.dtype
+ if d is torch.bfloat16:
+ with torch.autocast("cuda", enabled=False):
+ out = nn.functional.layer_norm(
+ x,
+ self.c_in,
+ self.weight.to(dtype=d),
+ self.bias.to(dtype=d),
+ self.eps,
+ )
+ else:
+ out = nn.functional.layer_norm(
+ x,
+ self.c_in,
+ self.weight,
+ self.bias,
+ self.eps,
+ )
+
+ return out
+
+
+@torch.jit.ignore
+def softmax_no_cast(t: torch.Tensor, dim: int = -1) -> torch.Tensor:
+ """
+ Softmax, but without automatic casting to fp32 when the input is of
+ type bfloat16
+ """
+ d = t.dtype
+ if d is torch.bfloat16:
+ with torch.autocast("cuda", enabled=False):
+ s = torch.nn.functional.softmax(t, dim=dim)
+ else:
+ s = torch.nn.functional.softmax(t, dim=dim)
+
+ return s
+
+
+# @torch.jit.script
+def _attention(
+ query: torch.Tensor,
+ key: torch.Tensor,
+ value: torch.Tensor,
+ biases: List[torch.Tensor],
+) -> torch.Tensor:
+ # [*, H, C_hidden, K]
+ key = permute_final_dims(key, (1, 0))
+
+ # [*, H, Q, K]
+ a = torch.matmul(query, key)
+
+ for b in biases:
+ a += b
+
+ a = softmax_no_cast(a, -1)
+
+ # [*, H, Q, C_hidden]
+ a = torch.matmul(a, value)
+
+ return a
+
+
+@torch.compiler.disable
+def kernel_triangular_attn(q, k, v, tri_bias, mask, scale):
+ from cuequivariance_torch.primitives.triangle import triangle_attention
+ return triangle_attention(q, k, v, tri_bias, mask=mask, scale=scale)
+
+
+class Attention(nn.Module):
+ """
+ Standard multi-head attention using AlphaFold's default layer
+ initialization. Allows multiple bias vectors.
+ """
+
+ def __init__(
+ self,
+ c_q: int,
+ c_k: int,
+ c_v: int,
+ c_hidden: int,
+ no_heads: int,
+ gating: bool = True,
+ ):
+ """Initialize the attention layer.
+
+ Parameters
+ ----------
+ c_q : int
+ Input dimension of query data
+ c_k : int
+ Input dimension of key data
+ c_v : int
+ Input dimension of value data
+ c_hidden : int
+ Per-head hidden dimension
+ no_heads : int
+ Number of attention heads
+ gating : bool, default=True
+ Whether the output should be gated using query data
+
+ """
+ super().__init__()
+
+ self.c_q = c_q
+ self.c_k = c_k
+ self.c_v = c_v
+ self.c_hidden = c_hidden
+ self.no_heads = no_heads
+ self.gating = gating
+
+ # DISCREPANCY: c_hidden is not the per-head channel dimension, as
+ # stated in the supplement, but the overall channel dimension.
+
+ self.linear_q = Linear(
+ self.c_q, self.c_hidden * self.no_heads, bias=False, init="glorot"
+ )
+ self.linear_k = Linear(
+ self.c_k, self.c_hidden * self.no_heads, bias=False, init="glorot"
+ )
+ self.linear_v = Linear(
+ self.c_v, self.c_hidden * self.no_heads, bias=False, init="glorot"
+ )
+ self.linear_o = Linear(
+ self.c_hidden * self.no_heads, self.c_q, bias=False, init="final"
+ )
+
+ self.linear_g = None
+ if self.gating:
+ self.linear_g = Linear(
+ self.c_q, self.c_hidden * self.no_heads, bias=False, init="gating"
+ )
+
+ self.sigmoid = nn.Sigmoid()
+
+ def _prep_qkv(
+ self, q_x: torch.Tensor, kv_x: torch.Tensor, apply_scale: bool = True
+ ) -> Tuple[torch.Tensor, torch.Tensor, torch.Tensor]:
+ # [*, Q/K/V, H * C_hidden]
+ q = self.linear_q(q_x)
+ k = self.linear_k(kv_x)
+ v = self.linear_v(kv_x)
+
+ # [*, Q/K, H, C_hidden]
+ q = q.view(q.shape[:-1] + (self.no_heads, -1))
+ k = k.view(k.shape[:-1] + (self.no_heads, -1))
+ v = v.view(v.shape[:-1] + (self.no_heads, -1))
+
+ # [*, H, Q/K, C_hidden]
+ q = q.transpose(-2, -3)
+ k = k.transpose(-2, -3)
+ v = v.transpose(-2, -3)
+
+ if apply_scale:
+ q /= math.sqrt(self.c_hidden)
+
+ return q, k, v
+
+ def _wrap_up(self, o: torch.Tensor, q_x: torch.Tensor) -> torch.Tensor:
+ if self.linear_g is not None:
+ g = self.sigmoid(self.linear_g(q_x))
+
+ # [*, Q, H, C_hidden]
+ g = g.view(g.shape[:-1] + (self.no_heads, -1))
+ o = o * g
+
+ # [*, Q, H * C_hidden]
+ o = flatten_final_dims(o, 2)
+
+ # [*, Q, C_q]
+ o = self.linear_o(o)
+
+ return o
+
+ def forward(
+ self,
+ q_x: torch.Tensor,
+ kv_x: torch.Tensor,
+ tri_bias: torch.Tensor,
+ mask_bias: torch.Tensor,
+ mask: torch.Tensor,
+ use_kernels: bool = False,
+ ) -> torch.Tensor:
+ """Compute attention.
+
+ Parameters
+ ----------
+ q_x : torch.Tensor
+ [*, Q, C_q] query data
+ kv_x : torch.Tensor
+ [*, K, C_k] key data
+ tri_bias : torch.Tensor
+ [*, H, Q, K] triangular bias
+ mask_bias : torch.Tensor
+ [*, H, Q, K] mask bias
+ mask : torch.Tensor
+ [*, Q, K] mask
+ use_kernels : bool, default=False
+ Whether to use optimized CUDA kernels
+
+ Returns
+ -------
+ [*, Q, C_q] attention update
+
+ """
+ # Attention kernel applies scaling internally
+ q, k, v = self._prep_qkv(
+ q_x,
+ kv_x,
+ apply_scale=not use_kernels,
+ )
+
+ if use_kernels:
+ scale = 1.0 / math.sqrt(self.c_hidden)
+ o = kernel_triangular_attn(
+ q,
+ k,
+ v,
+ tri_bias=tri_bias,
+ mask=mask.bool(),
+ scale=scale,
+ )
+ o = o.transpose(-2, -3)
+ else:
+ biases = [mask_bias, tri_bias]
+ o = _attention(q, k, v, biases)
+ o = o.transpose(-2, -3)
+
+ o = self._wrap_up(o, q_x)
+
+ return o
+
+
+def _trifast_attn(q, k, v, biases):
+ orig_n_dims = len(q.shape)
+
+ if len(biases) != 2:
+ raise ValueError(f"Trifast expects two bias terms, found {len(biases)}")
+
+ mask, b = biases
+
+ if len(b.shape) == 5:
+ # Sometimes there is an extra batch dim -- why?
+ b = b.squeeze(1)
+
+ if orig_n_dims == 4:
+ # add fake batch dim
+ q = q.unsqueeze(0)
+ k = k.unsqueeze(0)
+ v = v.unsqueeze(0)
+ # b = b.unsqueeze(0) not sure why this and only this has a batch dim?
+ mask = mask.unsqueeze(0)
+
+ if len(q.shape) != 5:
+ raise ValueError(f"Trifast expects q/k/v to be 5D, found {len(q.shape)}")
+
+ # Reorder q/k/v
+ q = rearrange(q, "b i h j d -> b h i j d")
+ k = rearrange(k, "b i h j d -> b h i j d")
+ v = rearrange(v, "b i h j d -> b h i j d")
+
+ # Make mask the right shape.
+ mask = rearrange(mask, "b i () () j -> b i j").bool()
+
+ # Delay import to here to avoid initializing cuda too early
+ from trifast import triangle_attention
+
+ o = triangle_attention(q, k, v, b, mask)
+ o = rearrange(o, "b h i j d -> b i j h d")
+
+ # Remove the batch dim if we added it.
+ if orig_n_dims == 4:
+ o = o.squeeze(0)
+ return o
diff --git a/forks/boltz/src/boltz/model/layers/triangular_attention/utils.py b/forks/boltz/src/boltz/model/layers/triangular_attention/utils.py
new file mode 100644
index 00000000..89899daa
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/triangular_attention/utils.py
@@ -0,0 +1,380 @@
+# Copyright 2021 AlQuraishi Laboratory
+#
+# Licensed under the Apache License, Version 2.0 (the "License");
+# you may not use this file except in compliance with the License.
+# You may obtain a copy of the License at
+#
+# http://www.apache.org/licenses/LICENSE-2.0
+#
+# Unless required by applicable law or agreed to in writing, software
+# distributed under the License is distributed on an "AS IS" BASIS,
+# WITHOUT WARRANTIES OR CONDITIONS OF ANY KIND, either express or implied.
+# See the License for the specific language governing permissions and
+# limitations under the License.
+
+from functools import partial
+from typing import Any, Callable, Dict, List, Optional, Sequence, Tuple
+
+import torch
+
+
+def add(m1, m2, inplace):
+ # The first operation in a checkpoint can't be in-place, but it's
+ # nice to have in-place addition during inference. Thus...
+ if not inplace:
+ m1 = m1 + m2
+ else:
+ m1 += m2
+
+ return m1
+
+
+def permute_final_dims(tensor: torch.Tensor, inds: List[int]):
+ zero_index = -1 * len(inds)
+ first_inds = list(range(len(tensor.shape[:zero_index])))
+ return tensor.permute(first_inds + [zero_index + i for i in inds])
+
+
+def is_fp16_enabled():
+ # Autocast world
+ fp16_enabled = torch.get_autocast_gpu_dtype() == torch.float16
+ fp16_enabled = fp16_enabled and torch.is_autocast_enabled()
+
+ return fp16_enabled
+
+
+# With tree_map, a poor man's JAX tree_map
+def dict_map(fn, dic, leaf_type):
+ new_dict = {}
+ for k, v in dic.items():
+ if type(v) is dict:
+ new_dict[k] = dict_map(fn, v, leaf_type)
+ else:
+ new_dict[k] = tree_map(fn, v, leaf_type)
+
+ return new_dict
+
+
+def tree_map(fn, tree, leaf_type):
+ if isinstance(tree, dict):
+ return dict_map(fn, tree, leaf_type)
+ elif isinstance(tree, list):
+ return [tree_map(fn, x, leaf_type) for x in tree]
+ elif isinstance(tree, tuple):
+ return tuple([tree_map(fn, x, leaf_type) for x in tree])
+ elif isinstance(tree, leaf_type):
+ return fn(tree)
+ else:
+ raise ValueError(f"Tree of type {type(tree)} not supported")
+
+
+tensor_tree_map = partial(tree_map, leaf_type=torch.Tensor)
+
+
+def flatten_final_dims(t: torch.Tensor, no_dims: int):
+ return t.reshape(t.shape[:-no_dims] + (-1,))
+
+
+def _fetch_dims(tree):
+ shapes = []
+ tree_type = type(tree)
+ if tree_type is dict:
+ for v in tree.values():
+ shapes.extend(_fetch_dims(v))
+ elif tree_type is list or tree_type is tuple:
+ for t in tree:
+ shapes.extend(_fetch_dims(t))
+ elif tree_type is torch.Tensor:
+ shapes.append(tree.shape)
+ else:
+ raise ValueError("Not supported")
+
+ return shapes
+
+
+@torch.jit.ignore
+def _flat_idx_to_idx(
+ flat_idx: int,
+ dims: Tuple[int],
+) -> Tuple[int]:
+ idx = []
+ for d in reversed(dims):
+ idx.append(flat_idx % d)
+ flat_idx = flat_idx // d
+
+ return tuple(reversed(idx))
+
+
+@torch.jit.ignore
+def _get_minimal_slice_set(
+ start: Sequence[int],
+ end: Sequence[int],
+ dims: int,
+ start_edges: Optional[Sequence[bool]] = None,
+ end_edges: Optional[Sequence[bool]] = None,
+) -> Sequence[Tuple[int]]:
+ """
+ Produces an ordered sequence of tensor slices that, when used in
+ sequence on a tensor with shape dims, yields tensors that contain every
+ leaf in the contiguous range [start, end]. Care is taken to yield a
+ short sequence of slices, and perhaps even the shortest possible (I'm
+ pretty sure it's the latter).
+
+ end is INCLUSIVE.
+ """
+
+ # start_edges and end_edges both indicate whether, starting from any given
+ # dimension, the start/end index is at the top/bottom edge of the
+ # corresponding tensor, modeled as a tree
+ def reduce_edge_list(l):
+ tally = 1
+ for i in range(len(l)):
+ reversed_idx = -1 * (i + 1)
+ l[reversed_idx] *= tally
+ tally = l[reversed_idx]
+
+ if start_edges is None:
+ start_edges = [s == 0 for s in start]
+ reduce_edge_list(start_edges)
+ if end_edges is None:
+ end_edges = [e == (d - 1) for e, d in zip(end, dims)]
+ reduce_edge_list(end_edges)
+
+ # Base cases. Either start/end are empty and we're done, or the final,
+ # one-dimensional tensor can be simply sliced
+ if len(start) == 0:
+ return [tuple()]
+ elif len(start) == 1:
+ return [(slice(start[0], end[0] + 1),)]
+
+ slices = []
+ path = []
+
+ # Dimensions common to start and end can be selected directly
+ for s, e in zip(start, end):
+ if s == e:
+ path.append(slice(s, s + 1))
+ else:
+ break
+
+ path = tuple(path)
+ divergence_idx = len(path)
+
+ # start == end, and we're done
+ if divergence_idx == len(dims):
+ return [tuple(path)]
+
+ def upper():
+ sdi = start[divergence_idx]
+ return [
+ path + (slice(sdi, sdi + 1),) + s
+ for s in _get_minimal_slice_set(
+ start[divergence_idx + 1 :],
+ [d - 1 for d in dims[divergence_idx + 1 :]],
+ dims[divergence_idx + 1 :],
+ start_edges=start_edges[divergence_idx + 1 :],
+ end_edges=[1 for _ in end_edges[divergence_idx + 1 :]],
+ )
+ ]
+
+ def lower():
+ edi = end[divergence_idx]
+ return [
+ path + (slice(edi, edi + 1),) + s
+ for s in _get_minimal_slice_set(
+ [0 for _ in start[divergence_idx + 1 :]],
+ end[divergence_idx + 1 :],
+ dims[divergence_idx + 1 :],
+ start_edges=[1 for _ in start_edges[divergence_idx + 1 :]],
+ end_edges=end_edges[divergence_idx + 1 :],
+ )
+ ]
+
+ # If both start and end are at the edges of the subtree rooted at
+ # divergence_idx, we can just select the whole subtree at once
+ if start_edges[divergence_idx] and end_edges[divergence_idx]:
+ slices.append(path + (slice(start[divergence_idx], end[divergence_idx] + 1),))
+ # If just start is at the edge, we can grab almost all of the subtree,
+ # treating only the ragged bottom edge as an edge case
+ elif start_edges[divergence_idx]:
+ slices.append(path + (slice(start[divergence_idx], end[divergence_idx]),))
+ slices.extend(lower())
+ # Analogous to the previous case, but the top is ragged this time
+ elif end_edges[divergence_idx]:
+ slices.extend(upper())
+ slices.append(
+ path + (slice(start[divergence_idx] + 1, end[divergence_idx] + 1),)
+ )
+ # If both sides of the range are ragged, we need to handle both sides
+ # separately. If there's contiguous meat in between them, we can index it
+ # in one big chunk
+ else:
+ slices.extend(upper())
+ middle_ground = end[divergence_idx] - start[divergence_idx]
+ if middle_ground > 1:
+ slices.append(
+ path + (slice(start[divergence_idx] + 1, end[divergence_idx]),)
+ )
+ slices.extend(lower())
+
+ return [tuple(s) for s in slices]
+
+
+@torch.jit.ignore
+def _chunk_slice(
+ t: torch.Tensor,
+ flat_start: int,
+ flat_end: int,
+ no_batch_dims: int,
+) -> torch.Tensor:
+ """
+ Equivalent to
+
+ t.reshape((-1,) + t.shape[no_batch_dims:])[flat_start:flat_end]
+
+ but without the need for the initial reshape call, which can be
+ memory-intensive in certain situations. The only reshape operations
+ in this function are performed on sub-tensors that scale with
+ (flat_end - flat_start), the chunk size.
+ """
+
+ batch_dims = t.shape[:no_batch_dims]
+ start_idx = list(_flat_idx_to_idx(flat_start, batch_dims))
+ # _get_minimal_slice_set is inclusive
+ end_idx = list(_flat_idx_to_idx(flat_end - 1, batch_dims))
+
+ # Get an ordered list of slices to perform
+ slices = _get_minimal_slice_set(
+ start_idx,
+ end_idx,
+ batch_dims,
+ )
+
+ sliced_tensors = [t[s] for s in slices]
+
+ return torch.cat([s.view((-1,) + t.shape[no_batch_dims:]) for s in sliced_tensors])
+
+
+def chunk_layer(
+ layer: Callable,
+ inputs: Dict[str, Any],
+ chunk_size: int,
+ no_batch_dims: int,
+ low_mem: bool = False,
+ _out: Any = None,
+ _add_into_out: bool = False,
+) -> Any:
+ """
+ Implements the "chunking" procedure described in section 1.11.8.
+
+ Layer outputs and inputs are assumed to be simple "pytrees,"
+ consisting only of (arbitrarily nested) lists, tuples, and dicts with
+ torch.Tensor leaves.
+
+ Args:
+ layer:
+ The layer to be applied chunk-wise
+ inputs:
+ A (non-nested) dictionary of keyworded inputs. All leaves must
+ be tensors and must share the same batch dimensions.
+ chunk_size:
+ The number of sub-batches per chunk. If multiple batch
+ dimensions are specified, a "sub-batch" is defined as a single
+ indexing of all batch dimensions simultaneously (s.t. the
+ number of sub-batches is the product of the batch dimensions).
+ no_batch_dims:
+ How many of the initial dimensions of each input tensor can
+ be considered batch dimensions.
+ low_mem:
+ Avoids flattening potentially large input tensors. Unnecessary
+ in most cases, and is ever so slightly slower than the default
+ setting.
+ Returns:
+ The reassembled output of the layer on the inputs.
+ """
+ if not (len(inputs) > 0):
+ raise ValueError("Must provide at least one input")
+
+ initial_dims = [shape[:no_batch_dims] for shape in _fetch_dims(inputs)]
+ orig_batch_dims = tuple([max(s) for s in zip(*initial_dims)])
+
+ def _prep_inputs(t):
+ if not low_mem:
+ if not sum(t.shape[:no_batch_dims]) == no_batch_dims:
+ t = t.expand(orig_batch_dims + t.shape[no_batch_dims:])
+ t = t.reshape(-1, *t.shape[no_batch_dims:])
+ else:
+ t = t.expand(orig_batch_dims + t.shape[no_batch_dims:])
+ return t
+
+ prepped_inputs = tensor_tree_map(_prep_inputs, inputs)
+ prepped_outputs = None
+ if _out is not None:
+ reshape_fn = lambda t: t.view([-1] + list(t.shape[no_batch_dims:]))
+ prepped_outputs = tensor_tree_map(reshape_fn, _out)
+
+ flat_batch_dim = 1
+ for d in orig_batch_dims:
+ flat_batch_dim *= d
+
+ no_chunks = flat_batch_dim // chunk_size + (flat_batch_dim % chunk_size != 0)
+
+ i = 0
+ out = prepped_outputs
+ for _ in range(no_chunks):
+ # Chunk the input
+ if not low_mem:
+ select_chunk = lambda t: t[i : i + chunk_size] if t.shape[0] != 1 else t
+ else:
+ select_chunk = partial(
+ _chunk_slice,
+ flat_start=i,
+ flat_end=min(flat_batch_dim, i + chunk_size),
+ no_batch_dims=len(orig_batch_dims),
+ )
+
+ chunks = tensor_tree_map(select_chunk, prepped_inputs)
+
+ # Run the layer on the chunk
+ output_chunk = layer(**chunks)
+
+ # Allocate space for the output
+ if out is None:
+ allocate = lambda t: t.new_zeros((flat_batch_dim,) + t.shape[1:])
+ out = tensor_tree_map(allocate, output_chunk)
+
+ # Put the chunk in its pre-allocated space
+ out_type = type(output_chunk)
+ if out_type is dict:
+
+ def assign(d1, d2):
+ for k, v in d1.items():
+ if type(v) is dict:
+ assign(v, d2[k])
+ else:
+ if _add_into_out:
+ v[i : i + chunk_size] += d2[k]
+ else:
+ v[i : i + chunk_size] = d2[k]
+
+ assign(out, output_chunk)
+ elif out_type is tuple:
+ for x1, x2 in zip(out, output_chunk):
+ if _add_into_out:
+ x1[i : i + chunk_size] += x2
+ else:
+ x1[i : i + chunk_size] = x2
+ elif out_type is torch.Tensor:
+ if _add_into_out:
+ out[i : i + chunk_size] += output_chunk
+ else:
+ out[i : i + chunk_size] = output_chunk
+ else:
+ raise ValueError("Not supported")
+
+ i += chunk_size
+
+ reshape = lambda t: t.view(orig_batch_dims + t.shape[1:])
+ out = tensor_tree_map(reshape, out)
+
+ return out
diff --git a/forks/boltz/src/boltz/model/layers/triangular_mult.py b/forks/boltz/src/boltz/model/layers/triangular_mult.py
new file mode 100644
index 00000000..5c52958a
--- /dev/null
+++ b/forks/boltz/src/boltz/model/layers/triangular_mult.py
@@ -0,0 +1,212 @@
+import torch
+from torch import Tensor, nn
+
+from boltz.model.layers import initialize as init
+
+
+@torch.compiler.disable
+def kernel_triangular_mult(
+ x,
+ direction,
+ mask,
+ norm_in_weight,
+ norm_in_bias,
+ p_in_weight,
+ g_in_weight,
+ norm_out_weight,
+ norm_out_bias,
+ p_out_weight,
+ g_out_weight,
+ eps,
+):
+ from cuequivariance_torch.primitives.triangle import triangle_multiplicative_update
+ return triangle_multiplicative_update(
+ x,
+ direction=direction,
+ mask=mask,
+ norm_in_weight=norm_in_weight,
+ norm_in_bias=norm_in_bias,
+ p_in_weight=p_in_weight,
+ g_in_weight=g_in_weight,
+ norm_out_weight=norm_out_weight,
+ norm_out_bias=norm_out_bias,
+ p_out_weight=p_out_weight,
+ g_out_weight=g_out_weight,
+ eps=eps,
+ )
+
+
+class TriangleMultiplicationOutgoing(nn.Module):
+ """TriangleMultiplicationOutgoing."""
+
+ def __init__(self, dim: int = 128) -> None:
+ """Initialize the TriangularUpdate module.
+
+ Parameters
+ ----------
+ dim: int
+ The dimension of the input, default 128
+
+ """
+ super().__init__()
+
+ self.norm_in = nn.LayerNorm(dim, eps=1e-5)
+ self.p_in = nn.Linear(dim, 2 * dim, bias=False)
+ self.g_in = nn.Linear(dim, 2 * dim, bias=False)
+
+ self.norm_out = nn.LayerNorm(dim)
+ self.p_out = nn.Linear(dim, dim, bias=False)
+ self.g_out = nn.Linear(dim, dim, bias=False)
+
+ init.bias_init_one_(self.norm_in.weight)
+ init.bias_init_zero_(self.norm_in.bias)
+
+ init.lecun_normal_init_(self.p_in.weight)
+ init.gating_init_(self.g_in.weight)
+
+ init.bias_init_one_(self.norm_out.weight)
+ init.bias_init_zero_(self.norm_out.bias)
+
+ init.final_init_(self.p_out.weight)
+ init.gating_init_(self.g_out.weight)
+
+ def forward(self, x: Tensor, mask: Tensor, use_kernels: bool = False) -> Tensor:
+ """Perform a forward pass.
+
+ Parameters
+ ----------
+ x: torch.Tensor
+ The input data of shape (B, N, N, D)
+ mask: torch.Tensor
+ The input mask of shape (B, N, N)
+ use_kernels: bool
+ Whether to use the kernel
+
+ Returns
+ -------
+ x: torch.Tensor
+ The output data of shape (B, N, N, D)
+
+ """
+ if use_kernels:
+ return kernel_triangular_mult(
+ x,
+ direction="outgoing",
+ mask=mask,
+ norm_in_weight=self.norm_in.weight,
+ norm_in_bias=self.norm_in.bias,
+ p_in_weight=self.p_in.weight,
+ g_in_weight=self.g_in.weight,
+ norm_out_weight=self.norm_out.weight,
+ norm_out_bias=self.norm_out.bias,
+ p_out_weight=self.p_out.weight,
+ g_out_weight=self.g_out.weight,
+ eps=1e-5,
+ )
+
+ # Input gating: D -> D
+ x = self.norm_in(x)
+ x_in = x
+ x = self.p_in(x) * self.g_in(x).sigmoid()
+
+ # Apply mask
+ x = x * mask.unsqueeze(-1)
+
+ # Split input and cast to float
+ a, b = torch.chunk(x.float(), 2, dim=-1)
+
+ # Triangular projection
+ x = torch.einsum("bikd,bjkd->bijd", a, b)
+
+ # Output gating
+ x = self.p_out(self.norm_out(x)) * self.g_out(x_in).sigmoid()
+
+ return x
+
+
+class TriangleMultiplicationIncoming(nn.Module):
+ """TriangleMultiplicationIncoming."""
+
+ def __init__(self, dim: int = 128) -> None:
+ """Initialize the TriangularUpdate module.
+
+ Parameters
+ ----------
+ dim: int
+ The dimension of the input, default 128
+
+ """
+ super().__init__()
+
+ self.norm_in = nn.LayerNorm(dim, eps=1e-5)
+ self.p_in = nn.Linear(dim, 2 * dim, bias=False)
+ self.g_in = nn.Linear(dim, 2 * dim, bias=False)
+
+ self.norm_out = nn.LayerNorm(dim)
+ self.p_out = nn.Linear(dim, dim, bias=False)
+ self.g_out = nn.Linear(dim, dim, bias=False)
+
+ init.bias_init_one_(self.norm_in.weight)
+ init.bias_init_zero_(self.norm_in.bias)
+
+ init.lecun_normal_init_(self.p_in.weight)
+ init.gating_init_(self.g_in.weight)
+
+ init.bias_init_one_(self.norm_out.weight)
+ init.bias_init_zero_(self.norm_out.bias)
+
+ init.final_init_(self.p_out.weight)
+ init.gating_init_(self.g_out.weight)
+
+ def forward(self, x: Tensor, mask: Tensor, use_kernels: bool = False) -> Tensor:
+ """Perform a forward pass.
+
+ Parameters
+ ----------
+ x: torch.Tensor
+ The input data of shape (B, N, N, D)
+ mask: torch.Tensor
+ The input mask of shape (B, N, N)
+ use_kernels: bool
+ Whether to use the kernel
+
+ Returns
+ -------
+ x: torch.Tensor
+ The output data of shape (B, N, N, D)
+
+ """
+ if use_kernels:
+ return kernel_triangular_mult(
+ x,
+ direction="incoming",
+ mask=mask,
+ norm_in_weight=self.norm_in.weight,
+ norm_in_bias=self.norm_in.bias,
+ p_in_weight=self.p_in.weight,
+ g_in_weight=self.g_in.weight,
+ norm_out_weight=self.norm_out.weight,
+ norm_out_bias=self.norm_out.bias,
+ p_out_weight=self.p_out.weight,
+ g_out_weight=self.g_out.weight,
+ eps=1e-5,
+ )
+
+ # Input gating: D -> D
+ x = self.norm_in(x)
+ x_in = x
+ x = self.p_in(x) * self.g_in(x).sigmoid()
+
+ # Apply mask
+ x = x * mask.unsqueeze(-1)
+
+ # Split input and cast to float
+ a, b = torch.chunk(x.float(), 2, dim=-1)
+
+ # Triangular projection
+ x = torch.einsum("bkid,bkjd->bijd", a, b)
+
+ # Output gating
+ x = self.p_out(self.norm_out(x)) * self.g_out(x_in).sigmoid()
+
+ return x
diff --git a/forks/boltz/src/boltz/model/loss/__init__.py b/forks/boltz/src/boltz/model/loss/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/model/loss/bfactor.py b/forks/boltz/src/boltz/model/loss/bfactor.py
new file mode 100644
index 00000000..c650f332
--- /dev/null
+++ b/forks/boltz/src/boltz/model/loss/bfactor.py
@@ -0,0 +1,49 @@
+import torch
+from torch import Tensor
+
+
+def bfactor_loss_fn(
+ output: dict[str, Tensor],
+ feats: dict[str, Tensor],
+) -> Tensor:
+ """Compute the bfactor loss.
+
+ Parameters
+ ----------
+ output : dict[str, Tensor]
+ Output of the model
+ feats : dict[str, Tensor]
+ Input features
+
+ Returns
+ -------
+ Tensor
+ The globally averaged loss.
+
+ """
+ with torch.autocast("cuda", enabled=False):
+ # Get predicted distograms
+ pred = output["pbfactor"].float() # (B, L, bins)
+ bins = pred.shape[2] # num_bins
+ token_to_rep_atom = feats["token_to_rep_atom"]
+
+ # Compute target histogram
+ bfactor_atom = feats["bfactor"].unsqueeze(-1) # (B, L)
+ bfactor_token = torch.bmm(token_to_rep_atom.float(), bfactor_atom)
+
+ boundaries = torch.linspace(0, 100, bins - 1, device=bfactor_token.device)
+ bfactor_token_bin = (bfactor_token > boundaries).sum(dim=-1).long()
+ bfactor_target = torch.nn.functional.one_hot(
+ bfactor_token_bin, num_classes=bins
+ )
+
+ # Combine target mask and padding mask
+ token_mask = (bfactor_token > 1e-5).squeeze(-1).float()
+
+ # Compute the bfactor loss
+ errors = -1 * torch.sum(
+ bfactor_target * torch.nn.functional.log_softmax(pred, dim=-1),
+ dim=-1,
+ )
+ loss = torch.sum(errors * token_mask) / (torch.sum(token_mask) + 1e-5)
+ return loss
diff --git a/forks/boltz/src/boltz/model/loss/confidence.py b/forks/boltz/src/boltz/model/loss/confidence.py
new file mode 100644
index 00000000..7080c9d6
--- /dev/null
+++ b/forks/boltz/src/boltz/model/loss/confidence.py
@@ -0,0 +1,590 @@
+import torch
+from torch import nn
+
+from boltz.data import const
+
+
+def confidence_loss(
+ model_out,
+ feats,
+ true_coords,
+ true_coords_resolved_mask,
+ multiplicity=1,
+ alpha_pae=0.0,
+):
+ """Compute confidence loss.
+
+ Parameters
+ ----------
+ model_out: Dict[str, torch.Tensor]
+ Dictionary containing the model output
+ feats: Dict[str, torch.Tensor]
+ Dictionary containing the model input
+ true_coords: torch.Tensor
+ The atom coordinates after symmetry correction
+ true_coords_resolved_mask: torch.Tensor
+ The resolved mask after symmetry correction
+ multiplicity: int, optional
+ The diffusion batch size, by default 1
+ alpha_pae: float, optional
+ The weight of the pae loss, by default 0.0
+
+ Returns
+ -------
+ Dict[str, torch.Tensor]
+ Loss breakdown
+
+ """
+ # Compute losses
+ plddt = plddt_loss(
+ model_out["plddt_logits"],
+ model_out["sample_atom_coords"],
+ true_coords,
+ true_coords_resolved_mask,
+ feats,
+ multiplicity=multiplicity,
+ )
+ pde = pde_loss(
+ model_out["pde_logits"],
+ model_out["sample_atom_coords"],
+ true_coords,
+ true_coords_resolved_mask,
+ feats,
+ multiplicity,
+ )
+ resolved = resolved_loss(
+ model_out["resolved_logits"],
+ feats,
+ true_coords_resolved_mask,
+ multiplicity=multiplicity,
+ )
+
+ pae = 0.0
+ if alpha_pae > 0.0:
+ pae = pae_loss(
+ model_out["pae_logits"],
+ model_out["sample_atom_coords"],
+ true_coords,
+ true_coords_resolved_mask,
+ feats,
+ multiplicity,
+ )
+
+ loss = plddt + pde + resolved + alpha_pae * pae
+
+ dict_out = {
+ "loss": loss,
+ "loss_breakdown": {
+ "plddt_loss": plddt,
+ "pde_loss": pde,
+ "resolved_loss": resolved,
+ "pae_loss": pae,
+ },
+ }
+ return dict_out
+
+
+def resolved_loss(
+ pred_resolved,
+ feats,
+ true_coords_resolved_mask,
+ multiplicity=1,
+):
+ """Compute resolved loss.
+
+ Parameters
+ ----------
+ pred_resolved: torch.Tensor
+ The resolved logits
+ feats: Dict[str, torch.Tensor]
+ Dictionary containing the model input
+ true_coords_resolved_mask: torch.Tensor
+ The resolved mask after symmetry correction
+ multiplicity: int, optional
+ The diffusion batch size, by default 1
+
+ Returns
+ -------
+ torch.Tensor
+ Resolved loss
+
+ """
+
+ # extract necessary features
+ token_to_rep_atom = feats["token_to_rep_atom"]
+ token_to_rep_atom = token_to_rep_atom.repeat_interleave(multiplicity, 0).float()
+ ref_mask = torch.bmm(
+ token_to_rep_atom, true_coords_resolved_mask.unsqueeze(-1).float()
+ ).squeeze(-1)
+ pad_mask = feats["token_pad_mask"]
+ pad_mask = pad_mask.repeat_interleave(multiplicity, 0).float()
+
+ # compute loss
+ log_softmax_resolved = torch.nn.functional.log_softmax(pred_resolved, dim=-1)
+ errors = (
+ -ref_mask * log_softmax_resolved[:, :, 0]
+ - (1 - ref_mask) * log_softmax_resolved[:, :, 1]
+ )
+ loss = torch.sum(errors * pad_mask, dim=-1) / (1e-7 + torch.sum(pad_mask, dim=-1))
+
+ # Average over the batch dimension
+ loss = torch.mean(loss)
+
+ return loss
+
+
+def plddt_loss(
+ pred_lddt,
+ pred_atom_coords,
+ true_atom_coords,
+ true_coords_resolved_mask,
+ feats,
+ multiplicity=1,
+):
+ """Compute plddt loss.
+
+ Parameters
+ ----------
+ pred_lddt: torch.Tensor
+ The plddt logits
+ pred_atom_coords: torch.Tensor
+ The predicted atom coordinates
+ true_atom_coords: torch.Tensor
+ The atom coordinates after symmetry correction
+ true_coords_resolved_mask: torch.Tensor
+ The resolved mask after symmetry correction
+ feats: Dict[str, torch.Tensor]
+ Dictionary containing the model input
+ multiplicity: int, optional
+ The diffusion batch size, by default 1
+
+ Returns
+ -------
+ torch.Tensor
+ Plddt loss
+
+ """
+
+ # extract necessary features
+ atom_mask = true_coords_resolved_mask
+
+ R_set_to_rep_atom = feats["r_set_to_rep_atom"]
+ R_set_to_rep_atom = R_set_to_rep_atom.repeat_interleave(multiplicity, 0).float()
+
+ token_type = feats["mol_type"]
+ token_type = token_type.repeat_interleave(multiplicity, 0)
+ is_nucleotide_token = (token_type == const.chain_type_ids["DNA"]).float() + (
+ token_type == const.chain_type_ids["RNA"]
+ ).float()
+
+ B = true_atom_coords.shape[0]
+
+ atom_to_token = feats["atom_to_token"].float()
+ atom_to_token = atom_to_token.repeat_interleave(multiplicity, 0)
+
+ token_to_rep_atom = feats["token_to_rep_atom"].float()
+ token_to_rep_atom = token_to_rep_atom.repeat_interleave(multiplicity, 0)
+
+ true_token_coords = torch.bmm(token_to_rep_atom, true_atom_coords)
+ pred_token_coords = torch.bmm(token_to_rep_atom, pred_atom_coords)
+
+ # compute true lddt
+ true_d = torch.cdist(
+ true_token_coords,
+ torch.bmm(R_set_to_rep_atom, true_atom_coords),
+ )
+ pred_d = torch.cdist(
+ pred_token_coords,
+ torch.bmm(R_set_to_rep_atom, pred_atom_coords),
+ )
+
+ # compute mask
+ pair_mask = atom_mask.unsqueeze(-1) * atom_mask.unsqueeze(-2)
+ pair_mask = (
+ pair_mask
+ * (1 - torch.eye(pair_mask.shape[1], device=pair_mask.device))[None, :, :]
+ )
+ pair_mask = torch.einsum("bnm,bkm->bnk", pair_mask, R_set_to_rep_atom)
+ pair_mask = torch.bmm(token_to_rep_atom, pair_mask)
+ atom_mask = torch.bmm(token_to_rep_atom, atom_mask.unsqueeze(-1).float())
+ is_nucleotide_R_element = torch.bmm(
+ R_set_to_rep_atom, torch.bmm(atom_to_token, is_nucleotide_token.unsqueeze(-1))
+ ).squeeze(-1)
+ cutoff = 15 + 15 * is_nucleotide_R_element.reshape(B, 1, -1).repeat(
+ 1, true_d.shape[1], 1
+ )
+
+ # compute lddt
+ target_lddt, mask_no_match = lddt_dist(
+ pred_d, true_d, pair_mask, cutoff, per_atom=True
+ )
+
+ # compute loss
+ num_bins = pred_lddt.shape[-1]
+ bin_index = torch.floor(target_lddt * num_bins).long()
+ bin_index = torch.clamp(bin_index, max=(num_bins - 1))
+ lddt_one_hot = nn.functional.one_hot(bin_index, num_classes=num_bins)
+ errors = -1 * torch.sum(
+ lddt_one_hot * torch.nn.functional.log_softmax(pred_lddt, dim=-1),
+ dim=-1,
+ )
+ atom_mask = atom_mask.squeeze(-1)
+ loss = torch.sum(errors * atom_mask * mask_no_match, dim=-1) / (
+ 1e-7 + torch.sum(atom_mask * mask_no_match, dim=-1)
+ )
+
+ # Average over the batch dimension
+ loss = torch.mean(loss)
+
+ return loss
+
+
+def pde_loss(
+ pred_pde,
+ pred_atom_coords,
+ true_atom_coords,
+ true_coords_resolved_mask,
+ feats,
+ multiplicity=1,
+ max_dist=32.0,
+):
+ """Compute pde loss.
+
+ Parameters
+ ----------
+ pred_pde: torch.Tensor
+ The pde logits
+ pred_atom_coords: torch.Tensor
+ The predicted atom coordinates
+ true_atom_coords: torch.Tensor
+ The atom coordinates after symmetry correction
+ true_coords_resolved_mask: torch.Tensor
+ The resolved mask after symmetry correction
+ feats: Dict[str, torch.Tensor]
+ Dictionary containing the model input
+ multiplicity: int, optional
+ The diffusion batch size, by default 1
+
+ Returns
+ -------
+ torch.Tensor
+ Pde loss
+
+ """
+
+ # extract necessary features
+ token_to_rep_atom = feats["token_to_rep_atom"]
+ token_to_rep_atom = token_to_rep_atom.repeat_interleave(multiplicity, 0).float()
+ token_mask = torch.bmm(
+ token_to_rep_atom, true_coords_resolved_mask.unsqueeze(-1).float()
+ ).squeeze(-1)
+ mask = token_mask.unsqueeze(-1) * token_mask.unsqueeze(-2)
+
+ # compute true pde
+ true_token_coords = torch.bmm(token_to_rep_atom, true_atom_coords)
+ pred_token_coords = torch.bmm(token_to_rep_atom, pred_atom_coords)
+
+ true_d = torch.cdist(true_token_coords, true_token_coords)
+ pred_d = torch.cdist(pred_token_coords, pred_token_coords)
+ target_pde = torch.abs(true_d - pred_d)
+
+ # compute loss
+ num_bins = pred_pde.shape[-1]
+ bin_index = torch.floor(target_pde * num_bins / max_dist).long()
+ bin_index = torch.clamp(bin_index, max=(num_bins - 1))
+ pde_one_hot = nn.functional.one_hot(bin_index, num_classes=num_bins)
+ errors = -1 * torch.sum(
+ pde_one_hot * torch.nn.functional.log_softmax(pred_pde, dim=-1),
+ dim=-1,
+ )
+ loss = torch.sum(errors * mask, dim=(-2, -1)) / (
+ 1e-7 + torch.sum(mask, dim=(-2, -1))
+ )
+
+ # Average over the batch dimension
+ loss = torch.mean(loss)
+
+ return loss
+
+
+def pae_loss(
+ pred_pae,
+ pred_atom_coords,
+ true_atom_coords,
+ true_coords_resolved_mask,
+ feats,
+ multiplicity=1,
+ max_dist=32.0,
+):
+ """Compute pae loss.
+
+ Parameters
+ ----------
+ pred_pae: torch.Tensor
+ The pae logits
+ pred_atom_coords: torch.Tensor
+ The predicted atom coordinates
+ true_atom_coords: torch.Tensor
+ The atom coordinates after symmetry correction
+ true_coords_resolved_mask: torch.Tensor
+ The resolved mask after symmetry correction
+ feats: Dict[str, torch.Tensor]
+ Dictionary containing the model input
+ multiplicity: int, optional
+ The diffusion batch size, by default 1
+
+ Returns
+ -------
+ torch.Tensor
+ Pae loss
+
+ """
+ # Retrieve frames and resolved masks
+ frames_idx_original = feats["frames_idx"]
+ mask_frame_true = feats["frame_resolved_mask"]
+
+ # Adjust the frames for nonpolymers after symmetry correction!
+ # NOTE: frames of polymers do not change under symmetry!
+ frames_idx_true, mask_collinear_true = compute_frame_pred(
+ true_atom_coords,
+ frames_idx_original,
+ feats,
+ multiplicity,
+ resolved_mask=true_coords_resolved_mask,
+ )
+
+ frame_true_atom_a, frame_true_atom_b, frame_true_atom_c = (
+ frames_idx_true[:, :, :, 0],
+ frames_idx_true[:, :, :, 1],
+ frames_idx_true[:, :, :, 2],
+ )
+ # Compute token coords in true frames
+ B, N, _ = true_atom_coords.shape
+ true_atom_coords = true_atom_coords.reshape(B // multiplicity, multiplicity, -1, 3)
+ true_coords_transformed = express_coordinate_in_frame(
+ true_atom_coords, frame_true_atom_a, frame_true_atom_b, frame_true_atom_c
+ )
+
+ # Compute pred frames and mask
+ frames_idx_pred, mask_collinear_pred = compute_frame_pred(
+ pred_atom_coords, frames_idx_original, feats, multiplicity
+ )
+ frame_pred_atom_a, frame_pred_atom_b, frame_pred_atom_c = (
+ frames_idx_pred[:, :, :, 0],
+ frames_idx_pred[:, :, :, 1],
+ frames_idx_pred[:, :, :, 2],
+ )
+ # Compute token coords in pred frames
+ B, N, _ = pred_atom_coords.shape
+ pred_atom_coords = pred_atom_coords.reshape(B // multiplicity, multiplicity, -1, 3)
+ pred_coords_transformed = express_coordinate_in_frame(
+ pred_atom_coords, frame_pred_atom_a, frame_pred_atom_b, frame_pred_atom_c
+ )
+
+ target_pae = torch.sqrt(
+ ((true_coords_transformed - pred_coords_transformed) ** 2).sum(-1) + 1e-8
+ )
+
+ # Compute mask for the pae loss
+ b_true_resolved_mask = true_coords_resolved_mask[
+ torch.arange(B // multiplicity)[:, None, None].to(
+ pred_coords_transformed.device
+ ),
+ frame_true_atom_b,
+ ]
+
+ pair_mask = (
+ mask_frame_true[:, None, :, None] # if true frame is invalid
+ * mask_collinear_true[:, :, :, None] # if true frame is invalid
+ * mask_collinear_pred[:, :, :, None] # if pred frame is invalid
+ * b_true_resolved_mask[:, :, None, :] # If atom j is not resolved
+ * feats["token_pad_mask"][:, None, :, None]
+ * feats["token_pad_mask"][:, None, None, :]
+ )
+
+ # compute loss
+ num_bins = pred_pae.shape[-1]
+ bin_index = torch.floor(target_pae * num_bins / max_dist).long()
+ bin_index = torch.clamp(bin_index, max=(num_bins - 1))
+ pae_one_hot = nn.functional.one_hot(bin_index, num_classes=num_bins)
+ errors = -1 * torch.sum(
+ pae_one_hot
+ * torch.nn.functional.log_softmax(pred_pae.reshape(pae_one_hot.shape), dim=-1),
+ dim=-1,
+ )
+ loss = torch.sum(errors * pair_mask, dim=(-2, -1)) / (
+ 1e-7 + torch.sum(pair_mask, dim=(-2, -1))
+ )
+ # Average over the batch dimension
+ loss = torch.mean(loss)
+
+ return loss
+
+
+def lddt_dist(dmat_predicted, dmat_true, mask, cutoff=15.0, per_atom=False):
+ # NOTE: the mask is a pairwise mask which should have the identity elements already masked out
+ # Compute mask over distances
+ dists_to_score = (dmat_true < cutoff).float() * mask
+ dist_l1 = torch.abs(dmat_true - dmat_predicted)
+
+ score = 0.25 * (
+ (dist_l1 < 0.5).float()
+ + (dist_l1 < 1.0).float()
+ + (dist_l1 < 2.0).float()
+ + (dist_l1 < 4.0).float()
+ )
+
+ # Normalize over the appropriate axes.
+ if per_atom:
+ mask_no_match = torch.sum(dists_to_score, dim=-1) != 0
+ norm = 1.0 / (1e-10 + torch.sum(dists_to_score, dim=-1))
+ score = norm * (1e-10 + torch.sum(dists_to_score * score, dim=-1))
+ return score, mask_no_match.float()
+ else:
+ norm = 1.0 / (1e-10 + torch.sum(dists_to_score, dim=(-2, -1)))
+ score = norm * (1e-10 + torch.sum(dists_to_score * score, dim=(-2, -1)))
+ total = torch.sum(dists_to_score, dim=(-1, -2))
+ return score, total
+
+
+def express_coordinate_in_frame(atom_coords, frame_atom_a, frame_atom_b, frame_atom_c):
+ batch, multiplicity = atom_coords.shape[0], atom_coords.shape[1]
+ batch_indices0 = torch.arange(batch)[:, None, None].to(atom_coords.device)
+ batch_indices1 = torch.arange(multiplicity)[None, :, None].to(atom_coords.device)
+
+ # extract frame atoms
+ a, b, c = (
+ atom_coords[batch_indices0, batch_indices1, frame_atom_a],
+ atom_coords[batch_indices0, batch_indices1, frame_atom_b],
+ atom_coords[batch_indices0, batch_indices1, frame_atom_c],
+ )
+ w1 = (a - b) / (torch.norm(a - b, dim=-1, keepdim=True) + 1e-5)
+ w2 = (c - b) / (torch.norm(c - b, dim=-1, keepdim=True) + 1e-5)
+
+ # build orthogonal frame
+ e1 = (w1 + w2) / (torch.norm(w1 + w2, dim=-1, keepdim=True) + 1e-5)
+ e2 = (w2 - w1) / (torch.norm(w2 - w1, dim=-1, keepdim=True) + 1e-5)
+ e3 = torch.linalg.cross(e1, e2)
+
+ # project onto frame basis
+ d = b[:, :, None, :, :] - b[:, :, :, None, :]
+ x_transformed = torch.cat(
+ [
+ torch.sum(d * e1[:, :, :, None, :], dim=-1, keepdim=True),
+ torch.sum(d * e2[:, :, :, None, :], dim=-1, keepdim=True),
+ torch.sum(d * e3[:, :, :, None, :], dim=-1, keepdim=True),
+ ],
+ dim=-1,
+ )
+ return x_transformed
+
+
+def compute_collinear_mask(v1, v2):
+ # Compute the mask for collinear or overlapping atoms
+ norm1 = torch.norm(v1, dim=1, keepdim=True)
+ norm2 = torch.norm(v2, dim=1, keepdim=True)
+ v1 = v1 / (norm1 + 1e-6)
+ v2 = v2 / (norm2 + 1e-6)
+ mask_angle = torch.abs(torch.sum(v1 * v2, dim=1)) < 0.9063
+ mask_overlap1 = norm1.reshape(-1) > 1e-2
+ mask_overlap2 = norm2.reshape(-1) > 1e-2
+ return mask_angle & mask_overlap1 & mask_overlap2
+
+
+def compute_frame_pred(
+ pred_atom_coords,
+ frames_idx_true,
+ feats,
+ multiplicity,
+ resolved_mask=None,
+ inference=False,
+):
+ # extract necessary features
+ asym_id_token = feats["asym_id"]
+ asym_id_atom = torch.bmm(
+ feats["atom_to_token"].float(), asym_id_token.unsqueeze(-1).float()
+ ).squeeze(-1)
+ B, N, _ = pred_atom_coords.shape
+ pred_atom_coords = pred_atom_coords.reshape(B // multiplicity, multiplicity, -1, 3)
+ frames_idx_pred = (
+ frames_idx_true.clone()
+ .repeat_interleave(multiplicity, 0)
+ .reshape(B // multiplicity, multiplicity, -1, 3)
+ )
+
+ # Iterate through the batch and update the frames for nonpolymers
+ for i, pred_atom_coord in enumerate(pred_atom_coords):
+ token_idx = 0
+ atom_idx = 0
+ for id in torch.unique(asym_id_token[i]):
+ mask_chain_token = (asym_id_token[i] == id) * feats["token_pad_mask"][i]
+ mask_chain_atom = (asym_id_atom[i] == id) * feats["atom_pad_mask"][i]
+ num_tokens = int(mask_chain_token.sum().item())
+ num_atoms = int(mask_chain_atom.sum().item())
+ if (
+ feats["mol_type"][i, token_idx] != const.chain_type_ids["NONPOLYMER"]
+ or num_atoms < 3
+ ):
+ token_idx += num_tokens
+ atom_idx += num_atoms
+ continue
+ dist_mat = (
+ (
+ pred_atom_coord[:, mask_chain_atom.bool()][:, None, :, :]
+ - pred_atom_coord[:, mask_chain_atom.bool()][:, :, None, :]
+ )
+ ** 2
+ ).sum(-1) ** 0.5
+
+ # Sort the atoms by distance
+ if inference:
+ resolved_pair = 1 - (
+ feats["atom_pad_mask"][i][mask_chain_atom.bool()][None, :]
+ * feats["atom_pad_mask"][i][mask_chain_atom.bool()][:, None]
+ ).to(torch.float32)
+ resolved_pair[resolved_pair == 1] = torch.inf
+ indices = torch.sort(dist_mat + resolved_pair, axis=2).indices
+ else:
+ if resolved_mask is None:
+ resolved_mask = feats["atom_resolved_mask"]
+ resolved_pair = 1 - (
+ resolved_mask[i][mask_chain_atom.bool()][None, :]
+ * resolved_mask[i][mask_chain_atom.bool()][:, None]
+ ).to(torch.float32)
+ resolved_pair[resolved_pair == 1] = torch.inf
+ indices = torch.sort(dist_mat + resolved_pair, axis=2).indices
+
+ # Compute the frames
+ frames = (
+ torch.cat(
+ [
+ indices[:, :, 1:2],
+ indices[:, :, 0:1],
+ indices[:, :, 2:3],
+ ],
+ dim=2,
+ )
+ + atom_idx
+ )
+ frames_idx_pred[i, :, token_idx : token_idx + num_atoms, :] = frames
+ token_idx += num_tokens
+ atom_idx += num_atoms
+
+ # Expand the frames with the multiplicity
+ frames_expanded = pred_atom_coords[
+ torch.arange(0, B // multiplicity, 1)[:, None, None, None].to(
+ frames_idx_pred.device
+ ),
+ torch.arange(0, multiplicity, 1)[None, :, None, None].to(
+ frames_idx_pred.device
+ ),
+ frames_idx_pred,
+ ].reshape(-1, 3, 3)
+
+ # Compute masks for collinear or overlapping atoms in the frame
+ mask_collinear_pred = compute_collinear_mask(
+ frames_expanded[:, 1] - frames_expanded[:, 0],
+ frames_expanded[:, 1] - frames_expanded[:, 2],
+ ).reshape(B // multiplicity, multiplicity, -1)
+
+ return frames_idx_pred, mask_collinear_pred * feats["token_pad_mask"][:, None, :]
diff --git a/forks/boltz/src/boltz/model/loss/confidencev2.py b/forks/boltz/src/boltz/model/loss/confidencev2.py
new file mode 100644
index 00000000..9f641ba4
--- /dev/null
+++ b/forks/boltz/src/boltz/model/loss/confidencev2.py
@@ -0,0 +1,621 @@
+import torch
+from torch import nn
+
+from boltz.data import const
+from boltz.model.layers.confidence_utils import compute_frame_pred, tm_function
+
+
+def confidence_loss(
+ model_out,
+ feats,
+ true_coords,
+ true_coords_resolved_mask,
+ token_level_confidence=False,
+ multiplicity=1,
+ alpha_pae=0.0,
+ mask_loss=None,
+ relative_supervision_weight=0.0,
+):
+ # TODO no support for MD yet!
+ # TODO only apply to the PDB structures not the distillation ones
+ plddt, rel_plddt = plddt_loss(
+ model_out["plddt_logits"],
+ model_out["sample_atom_coords"],
+ feats,
+ true_coords,
+ true_coords_resolved_mask,
+ token_level_confidence=token_level_confidence,
+ multiplicity=multiplicity,
+ mask_loss=mask_loss,
+ relative_confidence_supervision=relative_supervision_weight > 0.0,
+ relative_pred_lddt=model_out.get("relative_plddt_logits", None),
+ )
+ pde, rel_pde = pde_loss(
+ model_out["pde_logits"],
+ model_out["sample_atom_coords"],
+ feats,
+ true_coords,
+ true_coords_resolved_mask,
+ multiplicity,
+ mask_loss=mask_loss,
+ relative_confidence_supervision=relative_supervision_weight > 0.0,
+ relative_pred_pde=model_out.get("relative_pde_logits", None),
+ )
+ resolved = resolved_loss(
+ model_out["resolved_logits"],
+ feats,
+ true_coords_resolved_mask,
+ token_level_confidence=token_level_confidence,
+ multiplicity=multiplicity,
+ mask_loss=mask_loss,
+ )
+
+ pae, rel_pae = 0.0, 0.0
+ if alpha_pae > 0.0:
+ pae, rel_pae = pae_loss(
+ model_out["pae_logits"],
+ model_out["sample_atom_coords"],
+ feats,
+ true_coords,
+ true_coords_resolved_mask,
+ multiplicity,
+ mask_loss=mask_loss,
+ relative_confidence_supervision=relative_supervision_weight > 0.0,
+ relative_pred_pae=model_out.get("relative_pae_logits", None),
+ )
+
+ loss = (
+ plddt
+ + pde
+ + resolved
+ + alpha_pae * pae
+ + relative_supervision_weight * (rel_plddt + rel_pde + alpha_pae * rel_pae)
+ )
+
+ dict_out = {
+ "loss": loss,
+ "loss_breakdown": {
+ "plddt_loss": plddt,
+ "pde_loss": pde,
+ "resolved_loss": resolved,
+ "pae_loss": pae,
+ "rel_plddt_loss": rel_plddt,
+ "rel_pde_loss": rel_pde,
+ "rel_pae_loss": rel_pae,
+ },
+ }
+ return dict_out
+
+
+def resolved_loss(
+ pred_resolved,
+ feats,
+ true_coords_resolved_mask,
+ token_level_confidence=False,
+ multiplicity=1,
+ mask_loss=None,
+):
+ with torch.autocast("cuda", enabled=False):
+ if token_level_confidence:
+ token_to_rep_atom = feats["token_to_rep_atom"]
+ token_to_rep_atom = token_to_rep_atom.repeat_interleave(
+ multiplicity, 0
+ ).float()
+ ref_mask = torch.bmm(
+ token_to_rep_atom, true_coords_resolved_mask.unsqueeze(-1).float()
+ ).squeeze(-1)
+
+ pad_mask = feats["token_pad_mask"]
+ pad_mask = pad_mask.repeat_interleave(multiplicity, 0).float()
+ else:
+ ref_mask = true_coords_resolved_mask.float()
+ pad_mask = feats["atom_pad_mask"]
+ pad_mask = pad_mask.repeat_interleave(multiplicity, 0).float()
+ # compute loss
+ log_softmax_resolved = torch.nn.functional.log_softmax(
+ pred_resolved.float(), dim=-1
+ )
+ errors = (
+ -ref_mask * log_softmax_resolved[:, :, 0]
+ - (1 - ref_mask) * log_softmax_resolved[:, :, 1]
+ )
+ loss = torch.sum(errors * pad_mask, dim=-1) / (
+ 1e-7 + torch.sum(pad_mask, dim=-1)
+ )
+
+ # Average over the batch dimension
+ if mask_loss is not None:
+ mask_loss = (
+ mask_loss.repeat_interleave(multiplicity, 0)
+ .reshape(-1, multiplicity)
+ .float()
+ )
+ loss = torch.sum(loss.reshape(-1, multiplicity) * mask_loss) / (
+ torch.sum(mask_loss) + 1e-7
+ )
+ else:
+ loss = torch.mean(loss)
+ return loss
+
+
+def get_target_lddt(
+ pred_atom_coords,
+ feats,
+ true_atom_coords,
+ true_coords_resolved_mask,
+ token_level_confidence=True,
+ multiplicity=1,
+):
+ with torch.cuda.amp.autocast(enabled=False):
+ # extract necessary features
+ atom_mask = true_coords_resolved_mask
+
+ R_set_to_rep_atom = feats["r_set_to_rep_atom"]
+ R_set_to_rep_atom = R_set_to_rep_atom.repeat_interleave(multiplicity, 0).float()
+
+ token_type = feats["mol_type"]
+ token_type = token_type.repeat_interleave(multiplicity, 0)
+ is_nucleotide_token = (token_type == const.chain_type_ids["DNA"]).float() + (
+ token_type == const.chain_type_ids["RNA"]
+ ).float()
+
+ B = true_atom_coords.shape[0]
+
+ atom_to_token = feats["atom_to_token"].float()
+ atom_to_token = atom_to_token.repeat_interleave(multiplicity, 0)
+
+ token_to_rep_atom = feats["token_to_rep_atom"].float()
+ token_to_rep_atom = token_to_rep_atom.repeat_interleave(multiplicity, 0)
+
+ if token_level_confidence:
+ true_token_coords = torch.bmm(token_to_rep_atom, true_atom_coords)
+ pred_token_coords = torch.bmm(token_to_rep_atom, pred_atom_coords)
+
+ # compute true lddt
+ true_d = torch.cdist(
+ true_token_coords if token_level_confidence else true_atom_coords,
+ torch.bmm(R_set_to_rep_atom, true_atom_coords),
+ )
+ pred_d = torch.cdist(
+ pred_token_coords if token_level_confidence else pred_atom_coords,
+ torch.bmm(R_set_to_rep_atom, pred_atom_coords),
+ )
+
+ pair_mask = atom_mask.unsqueeze(-1) * atom_mask.unsqueeze(-2)
+ pair_mask = (
+ pair_mask
+ * (1 - torch.eye(pair_mask.shape[1], device=pair_mask.device))[None, :, :]
+ )
+ pair_mask = torch.einsum("bnm,bkm->bnk", pair_mask, R_set_to_rep_atom)
+
+ if token_level_confidence:
+ pair_mask = torch.bmm(token_to_rep_atom, pair_mask)
+ atom_mask = torch.bmm(token_to_rep_atom, atom_mask.unsqueeze(-1).float())
+ is_nucleotide_R_element = torch.bmm(
+ R_set_to_rep_atom,
+ torch.bmm(atom_to_token, is_nucleotide_token.unsqueeze(-1).float()),
+ ).squeeze(-1)
+ cutoff = 15 + 15 * is_nucleotide_R_element.reshape(B, 1, -1).repeat(
+ 1, true_d.shape[1], 1
+ )
+ target_lddt, mask_no_match = lddt_dist(
+ pred_d, true_d, pair_mask, cutoff, per_atom=True
+ )
+ return target_lddt, mask_no_match, atom_mask
+
+
+def plddt_loss(
+ pred_lddt,
+ pred_atom_coords,
+ feats,
+ true_atom_coords,
+ true_coords_resolved_mask,
+ token_level_confidence=False,
+ multiplicity=1,
+ mask_loss=None,
+ relative_confidence_supervision=False,
+ relative_pred_lddt=None,
+):
+ target_lddt, mask_no_match, atom_mask = get_target_lddt(
+ pred_atom_coords=pred_atom_coords,
+ feats=feats,
+ true_atom_coords=true_atom_coords,
+ true_coords_resolved_mask=true_coords_resolved_mask,
+ token_level_confidence=token_level_confidence,
+ multiplicity=multiplicity,
+ )
+
+ num_bins = pred_lddt.shape[-1]
+ bin_index = torch.floor(target_lddt * num_bins).long()
+ bin_index = torch.clamp(bin_index, max=(num_bins - 1))
+ lddt_one_hot = nn.functional.one_hot(bin_index, num_classes=num_bins)
+ errors = -1 * torch.sum(
+ lddt_one_hot * torch.nn.functional.log_softmax(pred_lddt, dim=-1),
+ dim=-1,
+ )
+ atom_mask = atom_mask.squeeze(-1)
+ loss = torch.sum(errors * atom_mask * mask_no_match, dim=-1) / (
+ 1e-7 + torch.sum(atom_mask * mask_no_match, dim=-1)
+ )
+ # Average over the batch dimension
+ if mask_loss is not None:
+ mask_loss = mask_loss.repeat_interleave(multiplicity, 0).reshape(
+ -1, multiplicity
+ )
+ loss = torch.sum(loss.reshape(-1, multiplicity) * mask_loss) / (
+ torch.sum(mask_loss) + 1e-7
+ )
+ else:
+ loss = torch.mean(loss)
+
+ rel_loss = 0.0
+ if relative_confidence_supervision:
+ # relative LDDT loss
+ B = true_atom_coords.shape[0]
+ relative_target_lddt = target_lddt.view(
+ B // multiplicity, multiplicity, 1, -1
+ ) - target_lddt.view(B // multiplicity, 1, multiplicity, -1)
+ rel_bin_index = torch.floor(
+ torch.abs(relative_target_lddt) * num_bins
+ ).long() * torch.sign(relative_target_lddt)
+ rel_bin_index = torch.clamp(
+ rel_bin_index, max=(num_bins - 1), min=-(num_bins - 1)
+ ).long() + (num_bins - 1)
+ rel_lddt_one_hot = nn.functional.one_hot(
+ rel_bin_index, num_classes=2 * num_bins - 1
+ )
+ rel_errors = -1 * torch.sum(
+ rel_lddt_one_hot
+ * torch.nn.functional.log_softmax(relative_pred_lddt, dim=-1),
+ dim=-1,
+ )
+ rel_atom_mask = atom_mask.view(B // multiplicity, multiplicity, 1, -1).repeat(
+ 1, 1, multiplicity, 1
+ )
+ rel_mask_no_match = mask_no_match.view(
+ B // multiplicity, multiplicity, 1, -1
+ ).repeat(1, 1, multiplicity, 1)
+ rel_loss = torch.sum(rel_errors * rel_atom_mask * rel_mask_no_match, dim=-1) / (
+ 1e-7 + torch.sum(rel_atom_mask * rel_mask_no_match, dim=-1)
+ )
+
+ if mask_loss is not None:
+ rel_mask_loss = mask_loss.view(B // multiplicity, multiplicity, 1).repeat(
+ 1, 1, multiplicity
+ )
+ rel_loss = torch.sum(rel_loss * rel_mask_loss) / (
+ torch.sum(rel_mask_loss) + 1e-7
+ )
+ else:
+ rel_loss = torch.mean(rel_loss)
+
+ return loss, rel_loss
+
+
+def lddt_dist(dmat_predicted, dmat_true, mask, cutoff=15.0, per_atom=False):
+ # NOTE: the mask is a pairwise mask which should have the identity elements already masked out
+ # Compute mask over distances
+ dists_to_score = (dmat_true < cutoff).float() * mask
+ dist_l1 = torch.abs(dmat_true - dmat_predicted)
+
+ score = 0.25 * (
+ (dist_l1 < 0.5).float()
+ + (dist_l1 < 1.0).float()
+ + (dist_l1 < 2.0).float()
+ + (dist_l1 < 4.0).float()
+ )
+
+ # Normalize over the appropriate axes.
+ if per_atom:
+ mask_no_match = torch.sum(dists_to_score, dim=-1) != 0
+ norm = 1.0 / (1e-10 + torch.sum(dists_to_score, dim=-1))
+ score = norm * (1e-10 + torch.sum(dists_to_score * score, dim=-1))
+ return score, mask_no_match.float()
+ else:
+ norm = 1.0 / (1e-10 + torch.sum(dists_to_score, dim=(-2, -1)))
+ score = norm * (1e-10 + torch.sum(dists_to_score * score, dim=(-2, -1)))
+ total = torch.sum(dists_to_score, dim=(-1, -2))
+ return score, total
+
+
+def express_coordinate_in_frame(atom_coords, frame_atom_a, frame_atom_b, frame_atom_c):
+ batch, multiplicity = atom_coords.shape[0], atom_coords.shape[1]
+ batch_indices0 = torch.arange(batch)[:, None, None].to(atom_coords.device)
+ batch_indices1 = torch.arange(multiplicity)[None, :, None].to(atom_coords.device)
+
+ # extract frame atoms
+ a, b, c = (
+ atom_coords[batch_indices0, batch_indices1, frame_atom_a],
+ atom_coords[batch_indices0, batch_indices1, frame_atom_b],
+ atom_coords[batch_indices0, batch_indices1, frame_atom_c],
+ )
+ w1 = (a - b) / (torch.norm(a - b, dim=-1, keepdim=True) + 1e-5)
+ w2 = (c - b) / (torch.norm(c - b, dim=-1, keepdim=True) + 1e-5)
+
+ # build orthogonal frame
+ e1 = (w1 + w2) / (torch.norm(w1 + w2, dim=-1, keepdim=True) + 1e-5)
+ e2 = (w2 - w1) / (torch.norm(w2 - w1, dim=-1, keepdim=True) + 1e-5)
+ e3 = torch.linalg.cross(e1, e2)
+
+ # NOTE: it is unclear based on what atom of the token the error is computed, here I will use the atom indicated by b (center of frame)
+
+ # project onto frame basis
+ d = b[:, :, None, :, :] - b[:, :, :, None, :]
+ x_transformed = torch.cat(
+ [
+ torch.sum(d * e1[:, :, :, None, :], dim=-1, keepdim=True),
+ torch.sum(d * e2[:, :, :, None, :], dim=-1, keepdim=True),
+ torch.sum(d * e3[:, :, :, None, :], dim=-1, keepdim=True),
+ ],
+ dim=-1,
+ )
+ return x_transformed
+
+
+def get_target_pae(
+ pred_atom_coords,
+ feats,
+ true_atom_coords,
+ true_coords_resolved_mask,
+ multiplicity=1,
+):
+ with torch.cuda.amp.autocast(enabled=False):
+ # Retrieve frames and resolved masks
+ frames_idx_original = feats["frames_idx"]
+ mask_frame_true = feats["frame_resolved_mask"]
+
+ # Adjust the frames for nonpolymers after symmetry correction!
+ # NOTE: frames of polymers do not change under symmetry!
+ frames_idx_true, mask_collinear_true = compute_frame_pred(
+ true_atom_coords,
+ frames_idx_original,
+ feats,
+ multiplicity,
+ resolved_mask=true_coords_resolved_mask,
+ )
+
+ frame_true_atom_a, frame_true_atom_b, frame_true_atom_c = (
+ frames_idx_true[:, :, :, 0],
+ frames_idx_true[:, :, :, 1],
+ frames_idx_true[:, :, :, 2],
+ )
+ # Compute token coords in true frames
+ B, N, _ = true_atom_coords.shape
+ true_atom_coords = true_atom_coords.reshape(
+ B // multiplicity, multiplicity, -1, 3
+ )
+ true_coords_transformed = express_coordinate_in_frame(
+ true_atom_coords, frame_true_atom_a, frame_true_atom_b, frame_true_atom_c
+ )
+
+ # Compute pred frames and mask
+ frames_idx_pred, mask_collinear_pred = compute_frame_pred(
+ pred_atom_coords, frames_idx_original, feats, multiplicity
+ )
+ frame_pred_atom_a, frame_pred_atom_b, frame_pred_atom_c = (
+ frames_idx_pred[:, :, :, 0],
+ frames_idx_pred[:, :, :, 1],
+ frames_idx_pred[:, :, :, 2],
+ )
+ # Compute token coords in pred frames
+ B, N, _ = pred_atom_coords.shape
+ pred_atom_coords = pred_atom_coords.reshape(
+ B // multiplicity, multiplicity, -1, 3
+ )
+ pred_coords_transformed = express_coordinate_in_frame(
+ pred_atom_coords, frame_pred_atom_a, frame_pred_atom_b, frame_pred_atom_c
+ )
+
+ target_pae = torch.sqrt(
+ ((true_coords_transformed - pred_coords_transformed) ** 2).sum(-1) + 1e-8
+ )
+
+ # Compute mask for the pae loss
+ b_true_resolved_mask = true_coords_resolved_mask[
+ torch.arange(B // multiplicity)[:, None, None].to(
+ pred_coords_transformed.device
+ ),
+ frame_true_atom_b,
+ ]
+
+ pair_mask = (
+ mask_frame_true[:, None, :, None] # if true frame is invalid
+ * mask_collinear_true[:, :, :, None] # if true frame is invalid
+ * mask_collinear_pred[:, :, :, None] # if pred frame is invalid
+ * b_true_resolved_mask[:, :, None, :] # If atom j is not resolved
+ * feats["token_pad_mask"][:, None, :, None]
+ * feats["token_pad_mask"][:, None, None, :]
+ )
+ return target_pae, pair_mask
+
+
+def pae_loss(
+ pred_pae,
+ pred_atom_coords,
+ feats,
+ true_atom_coords,
+ true_coords_resolved_mask,
+ multiplicity=1,
+ max_dist=32.0,
+ mask_loss=None,
+ relative_confidence_supervision=False,
+ relative_pred_pae=None,
+):
+ target_pae, pair_mask = get_target_pae(
+ pred_atom_coords=pred_atom_coords,
+ feats=feats,
+ true_atom_coords=true_atom_coords,
+ true_coords_resolved_mask=true_coords_resolved_mask,
+ multiplicity=multiplicity,
+ )
+
+ # compute loss
+ num_bins = pred_pae.shape[-1]
+ bin_index = torch.floor(target_pae * num_bins / max_dist).long()
+ bin_index = torch.clamp(bin_index, max=(num_bins - 1))
+ pae_one_hot = nn.functional.one_hot(bin_index, num_classes=num_bins)
+ errors = -1 * torch.sum(
+ pae_one_hot
+ * torch.nn.functional.log_softmax(pred_pae.reshape(pae_one_hot.shape), dim=-1),
+ dim=-1,
+ )
+ loss = torch.sum(errors * pair_mask, dim=(-2, -1)) / (
+ 1e-7 + torch.sum(pair_mask, dim=(-2, -1))
+ )
+ # Average over the batch dimension
+ if mask_loss is not None:
+ mask_loss = mask_loss.repeat_interleave(multiplicity, 0).reshape(
+ -1, multiplicity
+ )
+ loss = torch.sum(loss.reshape(-1, multiplicity) * mask_loss) / (
+ torch.sum(mask_loss) + 1e-7
+ )
+ else:
+ loss = torch.mean(loss)
+
+ rel_loss = 0.0
+ if relative_confidence_supervision:
+ B, N, _, _ = pred_pae.shape
+ rel_target_pae = target_pae.view(
+ B // multiplicity, multiplicity, 1, N, N
+ ) - target_pae.view(B // multiplicity, 1, multiplicity, N, N)
+ rel_bin_index = torch.floor(
+ torch.abs(rel_target_pae) * num_bins / max_dist
+ ).long() * torch.sign(rel_target_pae)
+ rel_bin_index = torch.clamp(
+ rel_bin_index, max=(num_bins - 1), min=-(num_bins - 1)
+ ).long() + (num_bins - 1)
+ rel_pae_one_hot = nn.functional.one_hot(
+ rel_bin_index, num_classes=2 * num_bins - 1
+ )
+ rel_errors = -1 * torch.sum(
+ rel_pae_one_hot
+ * torch.nn.functional.log_softmax(relative_pred_pae, dim=-1),
+ dim=-1,
+ )
+ rel_mask = pair_mask.view(B // multiplicity, multiplicity, 1, N, N).repeat(
+ 1, 1, multiplicity, 1, 1
+ )
+ rel_loss = torch.sum(rel_errors * rel_mask, dim=(-2, -1)) / (
+ 1e-7 + torch.sum(rel_mask, dim=(-2, -1))
+ )
+
+ if mask_loss is not None:
+ rel_mask_loss = mask_loss.view(B // multiplicity, multiplicity, 1).repeat(
+ 1, 1, multiplicity
+ )
+ rel_loss = torch.sum(rel_loss * rel_mask_loss) / (
+ torch.sum(rel_mask_loss) + 1e-7
+ )
+ else:
+ rel_loss = torch.mean(rel_loss)
+
+ return loss, rel_loss
+
+
+def get_target_pde(
+ pred_atom_coords,
+ feats,
+ true_atom_coords,
+ true_coords_resolved_mask,
+ multiplicity=1,
+):
+ with torch.cuda.amp.autocast(enabled=False):
+ # extract necessary features
+ token_to_rep_atom = feats["token_to_rep_atom"]
+ token_to_rep_atom = token_to_rep_atom.repeat_interleave(multiplicity, 0).float()
+ token_mask = torch.bmm(
+ token_to_rep_atom, true_coords_resolved_mask.unsqueeze(-1).float()
+ ).squeeze(-1)
+ mask = token_mask.unsqueeze(-1) * token_mask.unsqueeze(-2)
+
+ # compute true pde
+ true_token_coords = torch.bmm(token_to_rep_atom, true_atom_coords)
+ pred_token_coords = torch.bmm(token_to_rep_atom, pred_atom_coords)
+
+ true_d = torch.cdist(true_token_coords, true_token_coords)
+ pred_d = torch.cdist(pred_token_coords, pred_token_coords)
+ target_pde = torch.abs(true_d - pred_d)
+ return target_pde, mask
+
+
+def pde_loss(
+ pred_pde,
+ pred_atom_coords,
+ feats,
+ true_atom_coords,
+ true_coords_resolved_mask,
+ multiplicity=1,
+ max_dist=32.0,
+ mask_loss=None,
+ relative_confidence_supervision=False,
+ relative_pred_pde=None,
+):
+ target_pde, mask = get_target_pde(
+ pred_atom_coords=pred_atom_coords,
+ feats=feats,
+ true_atom_coords=true_atom_coords,
+ true_coords_resolved_mask=true_coords_resolved_mask,
+ multiplicity=multiplicity,
+ )
+ # compute loss
+ num_bins = pred_pde.shape[-1]
+ bin_index = torch.floor(target_pde * num_bins / max_dist).long()
+ bin_index = torch.clamp(bin_index, max=(num_bins - 1))
+ pde_one_hot = nn.functional.one_hot(bin_index, num_classes=num_bins)
+ errors = -1 * torch.sum(
+ pde_one_hot * torch.nn.functional.log_softmax(pred_pde, dim=-1),
+ dim=-1,
+ )
+ loss = torch.sum(errors * mask, dim=(-2, -1)) / (
+ 1e-7 + torch.sum(mask, dim=(-2, -1))
+ )
+ # Average over the batch dimension
+ if mask_loss is not None:
+ mask_loss = mask_loss.repeat_interleave(multiplicity, 0).reshape(
+ -1, multiplicity
+ )
+ loss = torch.sum(loss.reshape(-1, multiplicity) * mask_loss) / (
+ torch.sum(mask_loss) + 1e-7
+ )
+ else:
+ loss = torch.mean(loss)
+
+ rel_loss = 0.0
+ if relative_confidence_supervision:
+ B, N = target_pde.shape[:2]
+ rel_target_pde = target_pde.view(
+ B // multiplicity, multiplicity, 1, N, N
+ ) - target_pde.view(B // multiplicity, 1, multiplicity, N, N)
+ rel_bin_index = torch.floor(
+ torch.abs(rel_target_pde) * num_bins / max_dist
+ ).long() * torch.sign(rel_target_pde)
+ rel_bin_index = torch.clamp(
+ rel_bin_index, max=(num_bins - 1), min=-(num_bins - 1)
+ ).long() + (num_bins - 1)
+ rel_pde_one_hot = nn.functional.one_hot(
+ rel_bin_index, num_classes=2 * num_bins - 1
+ )
+ rel_errors = -1 * torch.sum(
+ rel_pde_one_hot
+ * torch.nn.functional.log_softmax(relative_pred_pde, dim=-1),
+ dim=-1,
+ )
+ rel_mask = mask.view(B // multiplicity, multiplicity, 1, N, N).repeat(
+ 1, 1, multiplicity, 1, 1
+ )
+ rel_loss = torch.sum(rel_errors * rel_mask, dim=(-2, -1)) / (
+ 1e-7 + torch.sum(rel_mask, dim=(-2, -1))
+ )
+
+ if mask_loss is not None:
+ rel_mask_loss = mask_loss.view(B // multiplicity, multiplicity, 1).repeat(
+ 1, 1, multiplicity
+ )
+ rel_loss = torch.sum(rel_loss * rel_mask_loss) / (
+ torch.sum(rel_mask_loss) + 1e-7
+ )
+ else:
+ rel_loss = torch.mean(rel_loss)
+
+ return loss, rel_loss
diff --git a/forks/boltz/src/boltz/model/loss/diffusion.py b/forks/boltz/src/boltz/model/loss/diffusion.py
new file mode 100644
index 00000000..3433e429
--- /dev/null
+++ b/forks/boltz/src/boltz/model/loss/diffusion.py
@@ -0,0 +1,171 @@
+# started from code from https://github.com/lucidrains/alphafold3-pytorch, MIT License, Copyright (c) 2024 Phil Wang
+
+from einops import einsum
+import torch
+import torch.nn.functional as F
+
+
+def weighted_rigid_align(
+ true_coords,
+ pred_coords,
+ weights,
+ mask,
+):
+ """Compute weighted alignment.
+
+ Parameters
+ ----------
+ true_coords: torch.Tensor
+ The ground truth atom coordinates
+ pred_coords: torch.Tensor
+ The predicted atom coordinates
+ weights: torch.Tensor
+ The weights for alignment
+ mask: torch.Tensor
+ The atoms mask
+
+ Returns
+ -------
+ torch.Tensor
+ Aligned coordinates
+
+ """
+
+ batch_size, num_points, dim = true_coords.shape
+ weights = (mask * weights).unsqueeze(-1)
+
+ # Compute weighted centroids
+ true_centroid = (true_coords * weights).sum(dim=1, keepdim=True) / weights.sum(
+ dim=1, keepdim=True
+ )
+ pred_centroid = (pred_coords * weights).sum(dim=1, keepdim=True) / weights.sum(
+ dim=1, keepdim=True
+ )
+
+ # Center the coordinates
+ true_coords_centered = true_coords - true_centroid
+ pred_coords_centered = pred_coords - pred_centroid
+
+ if num_points < (dim + 1):
+ print(
+ "Warning: The size of one of the point clouds is <= dim+1. "
+ + "`WeightedRigidAlign` cannot return a unique rotation."
+ )
+
+ # Compute the weighted covariance matrix
+ cov_matrix = einsum(
+ weights * pred_coords_centered, true_coords_centered, "b n i, b n j -> b i j"
+ )
+
+ # Compute the SVD of the covariance matrix, required float32 for svd and determinant
+ original_dtype = cov_matrix.dtype
+ cov_matrix_32 = cov_matrix.to(dtype=torch.float32)
+ U, S, V = torch.linalg.svd(
+ cov_matrix_32, driver="gesvd" if cov_matrix_32.is_cuda else None
+ )
+ V = V.mH
+
+ # Catch ambiguous rotation by checking the magnitude of singular values
+ if (S.abs() <= 1e-15).any() and not (num_points < (dim + 1)):
+ print(
+ "Warning: Excessively low rank of "
+ + "cross-correlation between aligned point clouds. "
+ + "`WeightedRigidAlign` cannot return a unique rotation."
+ )
+
+ # Compute the rotation matrix
+ rot_matrix = torch.einsum("b i j, b k j -> b i k", U, V).to(dtype=torch.float32)
+
+ # Ensure proper rotation matrix with determinant 1
+ F = torch.eye(dim, dtype=cov_matrix_32.dtype, device=cov_matrix.device)[
+ None
+ ].repeat(batch_size, 1, 1)
+ F[:, -1, -1] = torch.det(rot_matrix)
+ rot_matrix = einsum(U, F, V, "b i j, b j k, b l k -> b i l")
+ rot_matrix = rot_matrix.to(dtype=original_dtype)
+
+ # Apply the rotation and translation
+ aligned_coords = (
+ einsum(true_coords_centered, rot_matrix, "b n i, b j i -> b n j")
+ + pred_centroid
+ )
+ aligned_coords.detach_()
+
+ return aligned_coords
+
+
+def smooth_lddt_loss(
+ pred_coords,
+ true_coords,
+ is_nucleotide,
+ coords_mask,
+ nucleic_acid_cutoff: float = 30.0,
+ other_cutoff: float = 15.0,
+ multiplicity: int = 1,
+):
+ """Compute weighted alignment.
+
+ Parameters
+ ----------
+ pred_coords: torch.Tensor
+ The predicted atom coordinates
+ true_coords: torch.Tensor
+ The ground truth atom coordinates
+ is_nucleotide: torch.Tensor
+ The weights for alignment
+ coords_mask: torch.Tensor
+ The atoms mask
+ nucleic_acid_cutoff: float
+ The nucleic acid cutoff
+ other_cutoff: float
+ The non nucleic acid cutoff
+ multiplicity: int
+ The multiplicity
+ Returns
+ -------
+ torch.Tensor
+ Aligned coordinates
+
+ """
+ B, N, _ = true_coords.shape
+ true_dists = torch.cdist(true_coords, true_coords)
+ is_nucleotide = is_nucleotide.repeat_interleave(multiplicity, 0)
+
+ coords_mask = coords_mask.repeat_interleave(multiplicity, 0)
+ is_nucleotide_pair = is_nucleotide.unsqueeze(-1).expand(
+ -1, -1, is_nucleotide.shape[-1]
+ )
+
+ mask = (
+ is_nucleotide_pair * (true_dists < nucleic_acid_cutoff).float()
+ + (1 - is_nucleotide_pair) * (true_dists < other_cutoff).float()
+ )
+ mask = mask * (1 - torch.eye(pred_coords.shape[1], device=pred_coords.device))
+ mask = mask * (coords_mask.unsqueeze(-1) * coords_mask.unsqueeze(-2))
+
+ # Compute distances between all pairs of atoms
+ pred_dists = torch.cdist(pred_coords, pred_coords)
+ dist_diff = torch.abs(true_dists - pred_dists)
+
+ # Compute epsilon values
+ eps = (
+ (
+ (
+ F.sigmoid(0.5 - dist_diff)
+ + F.sigmoid(1.0 - dist_diff)
+ + F.sigmoid(2.0 - dist_diff)
+ + F.sigmoid(4.0 - dist_diff)
+ )
+ / 4.0
+ )
+ .view(multiplicity, B // multiplicity, N, N)
+ .mean(dim=0)
+ )
+
+ # Calculate masked averaging
+ eps = eps.repeat_interleave(multiplicity, 0)
+ num = (eps * mask).sum(dim=(-1, -2))
+ den = mask.sum(dim=(-1, -2)).clamp(min=1)
+ lddt = num / den
+
+ return 1.0 - lddt.mean()
diff --git a/forks/boltz/src/boltz/model/loss/diffusionv2.py b/forks/boltz/src/boltz/model/loss/diffusionv2.py
new file mode 100644
index 00000000..457ab838
--- /dev/null
+++ b/forks/boltz/src/boltz/model/loss/diffusionv2.py
@@ -0,0 +1,139 @@
+# started from code from https://github.com/lucidrains/alphafold3-pytorch, MIT License, Copyright (c) 2024 Phil Wang
+
+import einx
+import torch
+import torch.nn.functional as F
+from einops import einsum, rearrange
+
+
+def weighted_rigid_align(
+ true_coords, # Float['b n 3'], # true coordinates
+ pred_coords, # Float['b n 3'], # predicted coordinates
+ weights, # Float['b n'], # weights for each atom
+ mask, # Bool['b n'] | None = None # mask for variable lengths
+): # -> Float['b n 3']:
+ """Algorithm 28 : note there is a problem with the pseudocode in the paper where predicted and
+ GT are swapped in algorithm 28, but correct in equation (2)."""
+
+ out_shape = torch.broadcast_shapes(true_coords.shape, pred_coords.shape)
+ *batch_size, num_points, dim = out_shape
+ weights = (mask * weights).unsqueeze(-1)
+
+ # Compute weighted centroids
+ true_centroid = (true_coords * weights).sum(dim=-2, keepdim=True) / weights.sum(
+ dim=-2, keepdim=True
+ )
+ pred_centroid = (pred_coords * weights).sum(dim=-2, keepdim=True) / weights.sum(
+ dim=-2, keepdim=True
+ )
+
+ # Center the coordinates
+ true_coords_centered = true_coords - true_centroid
+ pred_coords_centered = pred_coords - pred_centroid
+
+ if torch.any(mask.sum(dim=-1) < (dim + 1)):
+ print(
+ "Warning: The size of one of the point clouds is <= dim+1. "
+ + "`WeightedRigidAlign` cannot return a unique rotation."
+ )
+
+ # Compute the weighted covariance matrix
+ cov_matrix = einsum(
+ weights * pred_coords_centered,
+ true_coords_centered,
+ "... n i, ... n j -> ... i j",
+ )
+
+ # Compute the SVD of the covariance matrix, required float32 for svd and determinant
+ original_dtype = cov_matrix.dtype
+ cov_matrix_32 = cov_matrix.to(dtype=torch.float32)
+
+ U, S, V = torch.linalg.svd(
+ cov_matrix_32, driver="gesvd" if cov_matrix_32.is_cuda else None
+ )
+ V = V.mH
+
+ # Catch ambiguous rotation by checking the magnitude of singular values
+ if (S.abs() <= 1e-15).any() and not (num_points < (dim + 1)):
+ print(
+ "Warning: Excessively low rank of "
+ + "cross-correlation between aligned point clouds. "
+ + "`WeightedRigidAlign` cannot return a unique rotation."
+ )
+
+ # Compute the rotation matrix
+ rot_matrix = torch.einsum("... i j, ... k j -> ... i k", U, V).to(
+ dtype=torch.float32
+ )
+
+ # Ensure proper rotation matrix with determinant 1
+ F = torch.eye(dim, dtype=cov_matrix_32.dtype, device=cov_matrix.device)[
+ None
+ ].repeat(*batch_size, 1, 1)
+ F[..., -1, -1] = torch.det(rot_matrix)
+ rot_matrix = einsum(U, F, V, "... i j, ... j k, ... l k -> ... i l")
+ rot_matrix = rot_matrix.to(dtype=original_dtype)
+
+ # Apply the rotation and translation
+ aligned_coords = (
+ einsum(true_coords_centered, rot_matrix, "... n i, ... j i -> ... n j")
+ + pred_centroid
+ )
+ aligned_coords.detach_()
+
+ return aligned_coords
+
+
+def smooth_lddt_loss(
+ pred_coords, # Float['b n 3'],
+ true_coords, # Float['b n 3'],
+ is_nucleotide, # Bool['b n'],
+ coords_mask, # Bool['b n'] | None = None,
+ nucleic_acid_cutoff: float = 30.0,
+ other_cutoff: float = 15.0,
+ multiplicity: int = 1,
+): # -> Float['']:
+ """Algorithm 27
+ pred_coords: predicted coordinates
+ true_coords: true coordinates
+ Note: for efficiency pred_coords is the only one with the multiplicity expanded
+ TODO: add weighing which overweight the smooth lddt contribution close to t=0 (not present in the paper)
+ """
+ lddt = []
+ for i in range(true_coords.shape[0]):
+ true_dists = torch.cdist(true_coords[i], true_coords[i])
+
+ is_nucleotide_i = is_nucleotide[i // multiplicity]
+ coords_mask_i = coords_mask[i // multiplicity]
+
+ is_nucleotide_pair = is_nucleotide_i.unsqueeze(-1).expand(
+ -1, is_nucleotide_i.shape[-1]
+ )
+
+ mask = is_nucleotide_pair * (true_dists < nucleic_acid_cutoff).float()
+ mask += (1 - is_nucleotide_pair) * (true_dists < other_cutoff).float()
+ mask *= 1 - torch.eye(pred_coords.shape[1], device=pred_coords.device)
+ mask *= coords_mask_i.unsqueeze(-1)
+ mask *= coords_mask_i.unsqueeze(-2)
+
+ valid_pairs = mask.nonzero()
+ true_dists_i = true_dists[valid_pairs[:, 0], valid_pairs[:, 1]]
+
+ pred_coords_i1 = pred_coords[i, valid_pairs[:, 0]]
+ pred_coords_i2 = pred_coords[i, valid_pairs[:, 1]]
+ pred_dists_i = F.pairwise_distance(pred_coords_i1, pred_coords_i2)
+
+ dist_diff_i = torch.abs(true_dists_i - pred_dists_i)
+
+ eps_i = (
+ F.sigmoid(0.5 - dist_diff_i)
+ + F.sigmoid(1.0 - dist_diff_i)
+ + F.sigmoid(2.0 - dist_diff_i)
+ + F.sigmoid(4.0 - dist_diff_i)
+ ) / 4.0
+
+ lddt_i = eps_i.sum() / (valid_pairs.shape[0] + 1e-5)
+ lddt.append(lddt_i)
+
+ # average over batch & multiplicity
+ return 1.0 - torch.stack(lddt, dim=0).mean(dim=0)
diff --git a/forks/boltz/src/boltz/model/loss/distogram.py b/forks/boltz/src/boltz/model/loss/distogram.py
new file mode 100644
index 00000000..6179d0a8
--- /dev/null
+++ b/forks/boltz/src/boltz/model/loss/distogram.py
@@ -0,0 +1,48 @@
+import torch
+from torch import Tensor
+
+
+def distogram_loss(
+ output: dict[str, Tensor],
+ feats: dict[str, Tensor],
+) -> tuple[Tensor, Tensor]:
+ """Compute the distogram loss.
+
+ Parameters
+ ----------
+ output : Dict[str, Tensor]
+ Output of the model
+ feats : Dict[str, Tensor]
+ Input features
+
+ Returns
+ -------
+ Tensor
+ The globally averaged loss.
+ Tensor
+ Per example loss.
+
+ """
+ # Get predicted distograms
+ pred = output["pdistogram"]
+
+ # Compute target distogram
+ target = feats["disto_target"]
+
+ # Combine target mask and padding mask
+ mask = feats["token_disto_mask"]
+ mask = mask[:, None, :] * mask[:, :, None]
+ mask = mask * (1 - torch.eye(mask.shape[1])[None]).to(pred)
+
+ # Compute the distogram loss
+ errors = -1 * torch.sum(
+ target * torch.nn.functional.log_softmax(pred, dim=-1),
+ dim=-1,
+ )
+ denom = 1e-5 + torch.sum(mask, dim=(-1, -2))
+ mean = errors * mask
+ mean = torch.sum(mean, dim=-1)
+ mean = mean / denom[..., None]
+ batch_loss = torch.sum(mean, dim=-1)
+ global_loss = torch.mean(batch_loss)
+ return global_loss, batch_loss
diff --git a/forks/boltz/src/boltz/model/loss/distogramv2.py b/forks/boltz/src/boltz/model/loss/distogramv2.py
new file mode 100644
index 00000000..1a72a28a
--- /dev/null
+++ b/forks/boltz/src/boltz/model/loss/distogramv2.py
@@ -0,0 +1,105 @@
+import torch
+from torch import Tensor
+
+
+def distogram_loss(
+ output: dict[str, Tensor],
+ feats: dict[str, Tensor],
+ aggregate_distogram: bool = True,
+) -> tuple[Tensor, Tensor]:
+ """Compute the distogram loss.
+
+ Parameters
+ ----------
+ output : Dict[str, Tensor]
+ Output of the model
+ feats : Dict[str, Tensor]
+ Input features
+
+ Returns
+ -------
+ Tensor
+ The globally averaged loss.
+ Tensor
+ Per example loss.
+
+ """
+ with torch.autocast("cuda", enabled=False):
+ # Get predicted distograms
+ pred = output["pdistogram"].float() # (B, L, L, num_distograms, disto_bins)
+ D = pred.shape[3] # num_distograms # noqa: N806
+ assert len(pred.shape) == 5 # noqa: PLR2004
+
+ # Compute target distogram
+ target = feats["disto_target"] # (B, L, L, K, disto_bins)
+ assert len(target.shape) == 5 # noqa: PLR2004
+
+ if aggregate_distogram:
+ msg = "Cannot aggregate GT distogram when num_distograms > 1"
+ assert pred.shape[3] == 1, msg
+
+ pred = pred.squeeze(3) # (B, L, L, disto_bins)
+
+ # Aggregate distogram over K conformers
+ target = target.sum(dim=3) # (B, L, L, disto_bins)
+
+ # Normalize distogram
+ P = target / target.sum(-1)[..., None].clamp(min=1) # noqa: N806
+
+ # Combine target mask and padding mask
+ mask = feats["token_disto_mask"]
+ mask = mask[:, None, :] * mask[:, :, None]
+ mask = mask * (1 - torch.eye(mask.shape[1])[None]).to(pred)
+
+ # Compute the distogram loss
+ log_Q = torch.nn.functional.log_softmax(pred, dim=-1) # noqa: N806
+ errors = -1 * torch.sum(
+ P * log_Q,
+ dim=-1,
+ )
+ denom = 1e-5 + torch.sum(mask, dim=(-1, -2))
+ mean = errors * mask
+ mean = torch.sum(mean, dim=-1)
+ mean = mean / denom[..., None]
+ batch_loss = torch.sum(mean, dim=-1)
+ global_loss = torch.mean(batch_loss)
+ else:
+ # We want to compute the loss for each pair of conformer K and predicted
+ # distogram
+
+ # Loop through conformers and compute the loss
+ batch_loss = []
+ for k in range(target.shape[3]):
+ # Get the target distogram for conformer k
+ # (B, L, L, K, disto_bins) -> (B, L, L, D, disto_bins)
+ P_k = target[:, :, :, k : k + 1, :].repeat_interleave(D, dim=3) # noqa: N806
+
+ # Compute the distogram loss to all predicted distograms
+ log_Q = torch.nn.functional.log_softmax(pred, dim=-1) # noqa: N806
+ errors = -1 * torch.sum(
+ P_k * log_Q,
+ dim=-1,
+ ) # (B, L, L, D)
+
+ # Compute mask
+ mask = feats["token_disto_mask"]
+ mask = mask[:, None, :] * mask[:, :, None]
+ mask = mask * (1 - torch.eye(mask.shape[1])[None]).to(pred)
+ mask = mask.unsqueeze(-1).repeat_interleave(D, -1) # (B, L, L, D)
+
+ denom = 1e-5 + torch.sum(mask, dim=(-2, -3)) # (B, D)
+ mean = errors * mask
+ mean = torch.sum(mean, dim=-2) # (B, L, D)
+ mean = mean / denom[..., None, :]
+ b_loss = torch.sum(mean, dim=-2) # (B, D)
+
+ batch_loss.append(b_loss)
+
+ batch_loss = torch.stack(batch_loss, dim=1) # (B, K, D)
+
+ # Compute the batch loss by taking the min over the predicted distograms
+ # and the average across conformers
+ batch_loss = torch.min(batch_loss, dim=-1).values.mean(dim=1)
+ global_loss = torch.mean(batch_loss)
+
+ return global_loss, batch_loss
diff --git a/forks/boltz/src/boltz/model/loss/validation.py b/forks/boltz/src/boltz/model/loss/validation.py
new file mode 100644
index 00000000..00d1aa7c
--- /dev/null
+++ b/forks/boltz/src/boltz/model/loss/validation.py
@@ -0,0 +1,1025 @@
+import torch
+
+from boltz.data import const
+from boltz.model.loss.confidence import (
+ compute_frame_pred,
+ express_coordinate_in_frame,
+ lddt_dist,
+)
+from boltz.model.loss.diffusion import weighted_rigid_align
+
+
+def factored_lddt_loss(
+ true_atom_coords,
+ pred_atom_coords,
+ feats,
+ atom_mask,
+ multiplicity=1,
+ cardinality_weighted=False,
+):
+ """Compute the lddt factorized into the different modalities.
+
+ Parameters
+ ----------
+ true_atom_coords : torch.Tensor
+ Ground truth atom coordinates after symmetry correction
+ pred_atom_coords : torch.Tensor
+ Predicted atom coordinates
+ feats : Dict[str, torch.Tensor]
+ Input features
+ atom_mask : torch.Tensor
+ Atom mask
+ multiplicity : int
+ Diffusion batch size, by default 1
+
+ Returns
+ -------
+ Dict[str, torch.Tensor]
+ The lddt for each modality
+ Dict[str, torch.Tensor]
+ The total number of pairs for each modality
+
+ """
+ # extract necessary features
+ atom_type = (
+ torch.bmm(
+ feats["atom_to_token"].float(), feats["mol_type"].unsqueeze(-1).float()
+ )
+ .squeeze(-1)
+ .long()
+ )
+ atom_type = atom_type.repeat_interleave(multiplicity, 0)
+
+ ligand_mask = (atom_type == const.chain_type_ids["NONPOLYMER"]).float()
+ dna_mask = (atom_type == const.chain_type_ids["DNA"]).float()
+ rna_mask = (atom_type == const.chain_type_ids["RNA"]).float()
+ protein_mask = (atom_type == const.chain_type_ids["PROTEIN"]).float()
+
+ nucleotide_mask = dna_mask + rna_mask
+
+ true_d = torch.cdist(true_atom_coords, true_atom_coords)
+ pred_d = torch.cdist(pred_atom_coords, pred_atom_coords)
+
+ pair_mask = atom_mask[:, :, None] * atom_mask[:, None, :]
+ pair_mask = (
+ pair_mask
+ * (1 - torch.eye(pair_mask.shape[1], device=pair_mask.device))[None, :, :]
+ )
+
+ cutoff = 15 + 15 * (
+ 1 - (1 - nucleotide_mask[:, :, None]) * (1 - nucleotide_mask[:, None, :])
+ )
+
+ # compute different lddts
+ dna_protein_mask = pair_mask * (
+ dna_mask[:, :, None] * protein_mask[:, None, :]
+ + protein_mask[:, :, None] * dna_mask[:, None, :]
+ )
+ dna_protein_lddt, dna_protein_total = lddt_dist(
+ pred_d, true_d, dna_protein_mask, cutoff
+ )
+ del dna_protein_mask
+
+ rna_protein_mask = pair_mask * (
+ rna_mask[:, :, None] * protein_mask[:, None, :]
+ + protein_mask[:, :, None] * rna_mask[:, None, :]
+ )
+ rna_protein_lddt, rna_protein_total = lddt_dist(
+ pred_d, true_d, rna_protein_mask, cutoff
+ )
+ del rna_protein_mask
+
+ ligand_protein_mask = pair_mask * (
+ ligand_mask[:, :, None] * protein_mask[:, None, :]
+ + protein_mask[:, :, None] * ligand_mask[:, None, :]
+ )
+ ligand_protein_lddt, ligand_protein_total = lddt_dist(
+ pred_d, true_d, ligand_protein_mask, cutoff
+ )
+ del ligand_protein_mask
+
+ dna_ligand_mask = pair_mask * (
+ dna_mask[:, :, None] * ligand_mask[:, None, :]
+ + ligand_mask[:, :, None] * dna_mask[:, None, :]
+ )
+ dna_ligand_lddt, dna_ligand_total = lddt_dist(
+ pred_d, true_d, dna_ligand_mask, cutoff
+ )
+ del dna_ligand_mask
+
+ rna_ligand_mask = pair_mask * (
+ rna_mask[:, :, None] * ligand_mask[:, None, :]
+ + ligand_mask[:, :, None] * rna_mask[:, None, :]
+ )
+ rna_ligand_lddt, rna_ligand_total = lddt_dist(
+ pred_d, true_d, rna_ligand_mask, cutoff
+ )
+ del rna_ligand_mask
+
+ intra_dna_mask = pair_mask * (dna_mask[:, :, None] * dna_mask[:, None, :])
+ intra_dna_lddt, intra_dna_total = lddt_dist(pred_d, true_d, intra_dna_mask, cutoff)
+ del intra_dna_mask
+
+ intra_rna_mask = pair_mask * (rna_mask[:, :, None] * rna_mask[:, None, :])
+ intra_rna_lddt, intra_rna_total = lddt_dist(pred_d, true_d, intra_rna_mask, cutoff)
+ del intra_rna_mask
+
+ chain_id = feats["asym_id"]
+ atom_chain_id = (
+ torch.bmm(feats["atom_to_token"].float(), chain_id.unsqueeze(-1).float())
+ .squeeze(-1)
+ .long()
+ )
+ atom_chain_id = atom_chain_id.repeat_interleave(multiplicity, 0)
+ same_chain_mask = (atom_chain_id[:, :, None] == atom_chain_id[:, None, :]).float()
+
+ intra_ligand_mask = (
+ pair_mask
+ * same_chain_mask
+ * (ligand_mask[:, :, None] * ligand_mask[:, None, :])
+ )
+ intra_ligand_lddt, intra_ligand_total = lddt_dist(
+ pred_d, true_d, intra_ligand_mask, cutoff
+ )
+ del intra_ligand_mask
+
+ intra_protein_mask = (
+ pair_mask
+ * same_chain_mask
+ * (protein_mask[:, :, None] * protein_mask[:, None, :])
+ )
+ intra_protein_lddt, intra_protein_total = lddt_dist(
+ pred_d, true_d, intra_protein_mask, cutoff
+ )
+ del intra_protein_mask
+
+ protein_protein_mask = (
+ pair_mask
+ * (1 - same_chain_mask)
+ * (protein_mask[:, :, None] * protein_mask[:, None, :])
+ )
+ protein_protein_lddt, protein_protein_total = lddt_dist(
+ pred_d, true_d, protein_protein_mask, cutoff
+ )
+ del protein_protein_mask
+
+ lddt_dict = {
+ "dna_protein": dna_protein_lddt,
+ "rna_protein": rna_protein_lddt,
+ "ligand_protein": ligand_protein_lddt,
+ "dna_ligand": dna_ligand_lddt,
+ "rna_ligand": rna_ligand_lddt,
+ "intra_ligand": intra_ligand_lddt,
+ "intra_dna": intra_dna_lddt,
+ "intra_rna": intra_rna_lddt,
+ "intra_protein": intra_protein_lddt,
+ "protein_protein": protein_protein_lddt,
+ }
+
+ total_dict = {
+ "dna_protein": dna_protein_total,
+ "rna_protein": rna_protein_total,
+ "ligand_protein": ligand_protein_total,
+ "dna_ligand": dna_ligand_total,
+ "rna_ligand": rna_ligand_total,
+ "intra_ligand": intra_ligand_total,
+ "intra_dna": intra_dna_total,
+ "intra_rna": intra_rna_total,
+ "intra_protein": intra_protein_total,
+ "protein_protein": protein_protein_total,
+ }
+ if not cardinality_weighted:
+ for key in total_dict:
+ total_dict[key] = (total_dict[key] > 0.0).float()
+
+ return lddt_dict, total_dict
+
+
+def factored_token_lddt_dist_loss(true_d, pred_d, feats, cardinality_weighted=False):
+ """Compute the distogram lddt factorized into the different modalities.
+
+ Parameters
+ ----------
+ true_d : torch.Tensor
+ Ground truth atom distogram
+ pred_d : torch.Tensor
+ Predicted atom distogram
+ feats : Dict[str, torch.Tensor]
+ Input features
+
+ Returns
+ -------
+ Tensor
+ The lddt for each modality
+ Tensor
+ The total number of pairs for each modality
+
+ """
+ # extract necessary features
+ token_type = feats["mol_type"]
+
+ ligand_mask = (token_type == const.chain_type_ids["NONPOLYMER"]).float()
+ dna_mask = (token_type == const.chain_type_ids["DNA"]).float()
+ rna_mask = (token_type == const.chain_type_ids["RNA"]).float()
+ protein_mask = (token_type == const.chain_type_ids["PROTEIN"]).float()
+ nucleotide_mask = dna_mask + rna_mask
+
+ token_mask = feats["token_disto_mask"]
+ token_mask = token_mask[:, :, None] * token_mask[:, None, :]
+ token_mask = token_mask * (1 - torch.eye(token_mask.shape[1])[None]).to(token_mask)
+
+ cutoff = 15 + 15 * (
+ 1 - (1 - nucleotide_mask[:, :, None]) * (1 - nucleotide_mask[:, None, :])
+ )
+
+ # compute different lddts
+ dna_protein_mask = token_mask * (
+ dna_mask[:, :, None] * protein_mask[:, None, :]
+ + protein_mask[:, :, None] * dna_mask[:, None, :]
+ )
+ dna_protein_lddt, dna_protein_total = lddt_dist(
+ pred_d, true_d, dna_protein_mask, cutoff
+ )
+
+ rna_protein_mask = token_mask * (
+ rna_mask[:, :, None] * protein_mask[:, None, :]
+ + protein_mask[:, :, None] * rna_mask[:, None, :]
+ )
+ rna_protein_lddt, rna_protein_total = lddt_dist(
+ pred_d, true_d, rna_protein_mask, cutoff
+ )
+
+ ligand_protein_mask = token_mask * (
+ ligand_mask[:, :, None] * protein_mask[:, None, :]
+ + protein_mask[:, :, None] * ligand_mask[:, None, :]
+ )
+ ligand_protein_lddt, ligand_protein_total = lddt_dist(
+ pred_d, true_d, ligand_protein_mask, cutoff
+ )
+
+ dna_ligand_mask = token_mask * (
+ dna_mask[:, :, None] * ligand_mask[:, None, :]
+ + ligand_mask[:, :, None] * dna_mask[:, None, :]
+ )
+ dna_ligand_lddt, dna_ligand_total = lddt_dist(
+ pred_d, true_d, dna_ligand_mask, cutoff
+ )
+
+ rna_ligand_mask = token_mask * (
+ rna_mask[:, :, None] * ligand_mask[:, None, :]
+ + ligand_mask[:, :, None] * rna_mask[:, None, :]
+ )
+ rna_ligand_lddt, rna_ligand_total = lddt_dist(
+ pred_d, true_d, rna_ligand_mask, cutoff
+ )
+
+ chain_id = feats["asym_id"]
+ same_chain_mask = (chain_id[:, :, None] == chain_id[:, None, :]).float()
+ intra_ligand_mask = (
+ token_mask
+ * same_chain_mask
+ * (ligand_mask[:, :, None] * ligand_mask[:, None, :])
+ )
+ intra_ligand_lddt, intra_ligand_total = lddt_dist(
+ pred_d, true_d, intra_ligand_mask, cutoff
+ )
+
+ intra_dna_mask = token_mask * (dna_mask[:, :, None] * dna_mask[:, None, :])
+ intra_dna_lddt, intra_dna_total = lddt_dist(pred_d, true_d, intra_dna_mask, cutoff)
+
+ intra_rna_mask = token_mask * (rna_mask[:, :, None] * rna_mask[:, None, :])
+ intra_rna_lddt, intra_rna_total = lddt_dist(pred_d, true_d, intra_rna_mask, cutoff)
+
+ chain_id = feats["asym_id"]
+ same_chain_mask = (chain_id[:, :, None] == chain_id[:, None, :]).float()
+
+ intra_protein_mask = (
+ token_mask
+ * same_chain_mask
+ * (protein_mask[:, :, None] * protein_mask[:, None, :])
+ )
+ intra_protein_lddt, intra_protein_total = lddt_dist(
+ pred_d, true_d, intra_protein_mask, cutoff
+ )
+
+ protein_protein_mask = (
+ token_mask
+ * (1 - same_chain_mask)
+ * (protein_mask[:, :, None] * protein_mask[:, None, :])
+ )
+ protein_protein_lddt, protein_protein_total = lddt_dist(
+ pred_d, true_d, protein_protein_mask, cutoff
+ )
+
+ lddt_dict = {
+ "dna_protein": dna_protein_lddt,
+ "rna_protein": rna_protein_lddt,
+ "ligand_protein": ligand_protein_lddt,
+ "dna_ligand": dna_ligand_lddt,
+ "rna_ligand": rna_ligand_lddt,
+ "intra_ligand": intra_ligand_lddt,
+ "intra_dna": intra_dna_lddt,
+ "intra_rna": intra_rna_lddt,
+ "intra_protein": intra_protein_lddt,
+ "protein_protein": protein_protein_lddt,
+ }
+
+ total_dict = {
+ "dna_protein": dna_protein_total,
+ "rna_protein": rna_protein_total,
+ "ligand_protein": ligand_protein_total,
+ "dna_ligand": dna_ligand_total,
+ "rna_ligand": rna_ligand_total,
+ "intra_ligand": intra_ligand_total,
+ "intra_dna": intra_dna_total,
+ "intra_rna": intra_rna_total,
+ "intra_protein": intra_protein_total,
+ "protein_protein": protein_protein_total,
+ }
+
+ if not cardinality_weighted:
+ for key in total_dict:
+ total_dict[key] = (total_dict[key] > 0.0).float()
+
+ return lddt_dict, total_dict
+
+
+def compute_plddt_mae(
+ pred_atom_coords,
+ feats,
+ true_atom_coords,
+ pred_lddt,
+ true_coords_resolved_mask,
+ multiplicity=1,
+):
+ """Compute the plddt mean absolute error.
+
+ Parameters
+ ----------
+ pred_atom_coords : torch.Tensor
+ Predicted atom coordinates
+ feats : torch.Tensor
+ Input features
+ true_atom_coords : torch.Tensor
+ Ground truth atom coordinates
+ pred_lddt : torch.Tensor
+ Predicted lddt
+ true_coords_resolved_mask : torch.Tensor
+ Resolved atom mask
+ multiplicity : int
+ Diffusion batch size, by default 1
+
+ Returns
+ -------
+ Tensor
+ The mae for each modality
+ Tensor
+ The total number of pairs for each modality
+
+ """
+ # extract necessary features
+ atom_mask = true_coords_resolved_mask
+ R_set_to_rep_atom = feats["r_set_to_rep_atom"]
+ R_set_to_rep_atom = R_set_to_rep_atom.repeat_interleave(multiplicity, 0).float()
+
+ token_type = feats["mol_type"]
+ token_type = token_type.repeat_interleave(multiplicity, 0)
+ is_nucleotide_token = (token_type == const.chain_type_ids["DNA"]).float() + (
+ token_type == const.chain_type_ids["RNA"]
+ ).float()
+
+ B = true_atom_coords.shape[0]
+
+ atom_to_token = feats["atom_to_token"].float()
+ atom_to_token = atom_to_token.repeat_interleave(multiplicity, 0)
+
+ token_to_rep_atom = feats["token_to_rep_atom"].float()
+ token_to_rep_atom = token_to_rep_atom.repeat_interleave(multiplicity, 0)
+
+ true_token_coords = torch.bmm(token_to_rep_atom, true_atom_coords)
+ pred_token_coords = torch.bmm(token_to_rep_atom, pred_atom_coords)
+
+ # compute true lddt
+ true_d = torch.cdist(
+ true_token_coords,
+ torch.bmm(R_set_to_rep_atom, true_atom_coords),
+ )
+ pred_d = torch.cdist(
+ pred_token_coords,
+ torch.bmm(R_set_to_rep_atom, pred_atom_coords),
+ )
+
+ pair_mask = atom_mask.unsqueeze(-1) * atom_mask.unsqueeze(-2)
+ pair_mask = (
+ pair_mask
+ * (1 - torch.eye(pair_mask.shape[1], device=pair_mask.device))[None, :, :]
+ )
+ pair_mask = torch.einsum("bnm,bkm->bnk", pair_mask, R_set_to_rep_atom)
+
+ pair_mask = torch.bmm(token_to_rep_atom, pair_mask)
+ atom_mask = torch.bmm(token_to_rep_atom, atom_mask.unsqueeze(-1).float()).squeeze(
+ -1
+ )
+ is_nucleotide_R_element = torch.bmm(
+ R_set_to_rep_atom, torch.bmm(atom_to_token, is_nucleotide_token.unsqueeze(-1))
+ ).squeeze(-1)
+ cutoff = 15 + 15 * is_nucleotide_R_element.reshape(B, 1, -1).repeat(
+ 1, true_d.shape[1], 1
+ )
+
+ target_lddt, mask_no_match = lddt_dist(
+ pred_d, true_d, pair_mask, cutoff, per_atom=True
+ )
+
+ protein_mask = (
+ (token_type == const.chain_type_ids["PROTEIN"]).float()
+ * atom_mask
+ * mask_no_match
+ )
+ ligand_mask = (
+ (token_type == const.chain_type_ids["NONPOLYMER"]).float()
+ * atom_mask
+ * mask_no_match
+ )
+ dna_mask = (
+ (token_type == const.chain_type_ids["DNA"]).float() * atom_mask * mask_no_match
+ )
+ rna_mask = (
+ (token_type == const.chain_type_ids["RNA"]).float() * atom_mask * mask_no_match
+ )
+
+ protein_mae = torch.sum(torch.abs(target_lddt - pred_lddt) * protein_mask) / (
+ torch.sum(protein_mask) + 1e-5
+ )
+ protein_total = torch.sum(protein_mask)
+ ligand_mae = torch.sum(torch.abs(target_lddt - pred_lddt) * ligand_mask) / (
+ torch.sum(ligand_mask) + 1e-5
+ )
+ ligand_total = torch.sum(ligand_mask)
+ dna_mae = torch.sum(torch.abs(target_lddt - pred_lddt) * dna_mask) / (
+ torch.sum(dna_mask) + 1e-5
+ )
+ dna_total = torch.sum(dna_mask)
+ rna_mae = torch.sum(torch.abs(target_lddt - pred_lddt) * rna_mask) / (
+ torch.sum(rna_mask) + 1e-5
+ )
+ rna_total = torch.sum(rna_mask)
+
+ mae_plddt_dict = {
+ "protein": protein_mae,
+ "ligand": ligand_mae,
+ "dna": dna_mae,
+ "rna": rna_mae,
+ }
+ total_dict = {
+ "protein": protein_total,
+ "ligand": ligand_total,
+ "dna": dna_total,
+ "rna": rna_total,
+ }
+
+ return mae_plddt_dict, total_dict
+
+
+def compute_pde_mae(
+ pred_atom_coords,
+ feats,
+ true_atom_coords,
+ pred_pde,
+ true_coords_resolved_mask,
+ multiplicity=1,
+):
+ """Compute the plddt mean absolute error.
+
+ Parameters
+ ----------
+ pred_atom_coords : torch.Tensor
+ Predicted atom coordinates
+ feats : torch.Tensor
+ Input features
+ true_atom_coords : torch.Tensor
+ Ground truth atom coordinates
+ pred_pde : torch.Tensor
+ Predicted pde
+ true_coords_resolved_mask : torch.Tensor
+ Resolved atom mask
+ multiplicity : int
+ Diffusion batch size, by default 1
+
+ Returns
+ -------
+ Tensor
+ The mae for each modality
+ Tensor
+ The total number of pairs for each modality
+
+ """
+ # extract necessary features
+ token_to_rep_atom = feats["token_to_rep_atom"].float()
+ token_to_rep_atom = token_to_rep_atom.repeat_interleave(multiplicity, 0)
+
+ token_mask = torch.bmm(
+ token_to_rep_atom, true_coords_resolved_mask.unsqueeze(-1).float()
+ ).squeeze(-1)
+
+ token_type = feats["mol_type"]
+ token_type = token_type.repeat_interleave(multiplicity, 0)
+
+ true_token_coords = torch.bmm(token_to_rep_atom, true_atom_coords)
+ pred_token_coords = torch.bmm(token_to_rep_atom, pred_atom_coords)
+
+ # compute true pde
+ true_d = torch.cdist(true_token_coords, true_token_coords)
+ pred_d = torch.cdist(pred_token_coords, pred_token_coords)
+ target_pde = (
+ torch.clamp(
+ torch.floor(torch.abs(true_d - pred_d) * 64 / 32).long(), max=63
+ ).float()
+ * 0.5
+ + 0.25
+ )
+
+ pair_mask = token_mask.unsqueeze(-1) * token_mask.unsqueeze(-2)
+ pair_mask = (
+ pair_mask
+ * (1 - torch.eye(pair_mask.shape[1], device=pair_mask.device))[None, :, :]
+ )
+
+ protein_mask = (token_type == const.chain_type_ids["PROTEIN"]).float()
+ ligand_mask = (token_type == const.chain_type_ids["NONPOLYMER"]).float()
+ dna_mask = (token_type == const.chain_type_ids["DNA"]).float()
+ rna_mask = (token_type == const.chain_type_ids["RNA"]).float()
+
+ # compute different pdes
+ dna_protein_mask = pair_mask * (
+ dna_mask[:, :, None] * protein_mask[:, None, :]
+ + protein_mask[:, :, None] * dna_mask[:, None, :]
+ )
+ dna_protein_mae = torch.sum(torch.abs(target_pde - pred_pde) * dna_protein_mask) / (
+ torch.sum(dna_protein_mask) + 1e-5
+ )
+ dna_protein_total = torch.sum(dna_protein_mask)
+
+ rna_protein_mask = pair_mask * (
+ rna_mask[:, :, None] * protein_mask[:, None, :]
+ + protein_mask[:, :, None] * rna_mask[:, None, :]
+ )
+ rna_protein_mae = torch.sum(torch.abs(target_pde - pred_pde) * rna_protein_mask) / (
+ torch.sum(rna_protein_mask) + 1e-5
+ )
+ rna_protein_total = torch.sum(rna_protein_mask)
+
+ ligand_protein_mask = pair_mask * (
+ ligand_mask[:, :, None] * protein_mask[:, None, :]
+ + protein_mask[:, :, None] * ligand_mask[:, None, :]
+ )
+ ligand_protein_mae = torch.sum(
+ torch.abs(target_pde - pred_pde) * ligand_protein_mask
+ ) / (torch.sum(ligand_protein_mask) + 1e-5)
+ ligand_protein_total = torch.sum(ligand_protein_mask)
+
+ dna_ligand_mask = pair_mask * (
+ dna_mask[:, :, None] * ligand_mask[:, None, :]
+ + ligand_mask[:, :, None] * dna_mask[:, None, :]
+ )
+ dna_ligand_mae = torch.sum(torch.abs(target_pde - pred_pde) * dna_ligand_mask) / (
+ torch.sum(dna_ligand_mask) + 1e-5
+ )
+ dna_ligand_total = torch.sum(dna_ligand_mask)
+
+ rna_ligand_mask = pair_mask * (
+ rna_mask[:, :, None] * ligand_mask[:, None, :]
+ + ligand_mask[:, :, None] * rna_mask[:, None, :]
+ )
+ rna_ligand_mae = torch.sum(torch.abs(target_pde - pred_pde) * rna_ligand_mask) / (
+ torch.sum(rna_ligand_mask) + 1e-5
+ )
+ rna_ligand_total = torch.sum(rna_ligand_mask)
+
+ intra_ligand_mask = pair_mask * (ligand_mask[:, :, None] * ligand_mask[:, None, :])
+ intra_ligand_mae = torch.sum(
+ torch.abs(target_pde - pred_pde) * intra_ligand_mask
+ ) / (torch.sum(intra_ligand_mask) + 1e-5)
+ intra_ligand_total = torch.sum(intra_ligand_mask)
+
+ intra_dna_mask = pair_mask * (dna_mask[:, :, None] * dna_mask[:, None, :])
+ intra_dna_mae = torch.sum(torch.abs(target_pde - pred_pde) * intra_dna_mask) / (
+ torch.sum(intra_dna_mask) + 1e-5
+ )
+ intra_dna_total = torch.sum(intra_dna_mask)
+
+ intra_rna_mask = pair_mask * (rna_mask[:, :, None] * rna_mask[:, None, :])
+ intra_rna_mae = torch.sum(torch.abs(target_pde - pred_pde) * intra_rna_mask) / (
+ torch.sum(intra_rna_mask) + 1e-5
+ )
+ intra_rna_total = torch.sum(intra_rna_mask)
+
+ chain_id = feats["asym_id"].repeat_interleave(multiplicity, 0)
+ same_chain_mask = (chain_id[:, :, None] == chain_id[:, None, :]).float()
+
+ intra_protein_mask = (
+ pair_mask
+ * same_chain_mask
+ * (protein_mask[:, :, None] * protein_mask[:, None, :])
+ )
+ intra_protein_mae = torch.sum(
+ torch.abs(target_pde - pred_pde) * intra_protein_mask
+ ) / (torch.sum(intra_protein_mask) + 1e-5)
+ intra_protein_total = torch.sum(intra_protein_mask)
+
+ protein_protein_mask = (
+ pair_mask
+ * (1 - same_chain_mask)
+ * (protein_mask[:, :, None] * protein_mask[:, None, :])
+ )
+ protein_protein_mae = torch.sum(
+ torch.abs(target_pde - pred_pde) * protein_protein_mask
+ ) / (torch.sum(protein_protein_mask) + 1e-5)
+ protein_protein_total = torch.sum(protein_protein_mask)
+
+ mae_pde_dict = {
+ "dna_protein": dna_protein_mae,
+ "rna_protein": rna_protein_mae,
+ "ligand_protein": ligand_protein_mae,
+ "dna_ligand": dna_ligand_mae,
+ "rna_ligand": rna_ligand_mae,
+ "intra_ligand": intra_ligand_mae,
+ "intra_dna": intra_dna_mae,
+ "intra_rna": intra_rna_mae,
+ "intra_protein": intra_protein_mae,
+ "protein_protein": protein_protein_mae,
+ }
+ total_pde_dict = {
+ "dna_protein": dna_protein_total,
+ "rna_protein": rna_protein_total,
+ "ligand_protein": ligand_protein_total,
+ "dna_ligand": dna_ligand_total,
+ "rna_ligand": rna_ligand_total,
+ "intra_ligand": intra_ligand_total,
+ "intra_dna": intra_dna_total,
+ "intra_rna": intra_rna_total,
+ "intra_protein": intra_protein_total,
+ "protein_protein": protein_protein_total,
+ }
+
+ return mae_pde_dict, total_pde_dict
+
+
+def compute_pae_mae(
+ pred_atom_coords,
+ feats,
+ true_atom_coords,
+ pred_pae,
+ true_coords_resolved_mask,
+ multiplicity=1,
+):
+ """Compute the pae mean absolute error.
+
+ Parameters
+ ----------
+ pred_atom_coords : torch.Tensor
+ Predicted atom coordinates
+ feats : torch.Tensor
+ Input features
+ true_atom_coords : torch.Tensor
+ Ground truth atom coordinates
+ pred_pae : torch.Tensor
+ Predicted pae
+ true_coords_resolved_mask : torch.Tensor
+ Resolved atom mask
+ multiplicity : int
+ Diffusion batch size, by default 1
+
+ Returns
+ -------
+ Tensor
+ The mae for each modality
+ Tensor
+ The total number of pairs for each modality
+
+ """
+ # Retrieve frames and resolved masks
+ frames_idx_original = feats["frames_idx"]
+ mask_frame_true = feats["frame_resolved_mask"]
+
+ # Adjust the frames for nonpolymers after symmetry correction!
+ # NOTE: frames of polymers do not change under symmetry!
+ frames_idx_true, mask_collinear_true = compute_frame_pred(
+ true_atom_coords,
+ frames_idx_original,
+ feats,
+ multiplicity,
+ resolved_mask=true_coords_resolved_mask,
+ )
+
+ frame_true_atom_a, frame_true_atom_b, frame_true_atom_c = (
+ frames_idx_true[:, :, :, 0],
+ frames_idx_true[:, :, :, 1],
+ frames_idx_true[:, :, :, 2],
+ )
+ # Compute token coords in true frames
+ B, N, _ = true_atom_coords.shape
+ true_atom_coords = true_atom_coords.reshape(B // multiplicity, multiplicity, -1, 3)
+ true_coords_transformed = express_coordinate_in_frame(
+ true_atom_coords, frame_true_atom_a, frame_true_atom_b, frame_true_atom_c
+ )
+
+ # Compute pred frames and mask
+ frames_idx_pred, mask_collinear_pred = compute_frame_pred(
+ pred_atom_coords, frames_idx_original, feats, multiplicity
+ )
+ frame_pred_atom_a, frame_pred_atom_b, frame_pred_atom_c = (
+ frames_idx_pred[:, :, :, 0],
+ frames_idx_pred[:, :, :, 1],
+ frames_idx_pred[:, :, :, 2],
+ )
+ # Compute token coords in pred frames
+ B, N, _ = pred_atom_coords.shape
+ pred_atom_coords = pred_atom_coords.reshape(B // multiplicity, multiplicity, -1, 3)
+ pred_coords_transformed = express_coordinate_in_frame(
+ pred_atom_coords, frame_pred_atom_a, frame_pred_atom_b, frame_pred_atom_c
+ )
+
+ target_pae_continuous = torch.sqrt(
+ ((true_coords_transformed - pred_coords_transformed) ** 2).sum(-1) + 1e-8
+ )
+ target_pae = (
+ torch.clamp(torch.floor(target_pae_continuous * 64 / 32).long(), max=63).float()
+ * 0.5
+ + 0.25
+ )
+
+ # Compute mask for the pae loss
+ b_true_resolved_mask = true_coords_resolved_mask[
+ torch.arange(B // multiplicity)[:, None, None].to(
+ pred_coords_transformed.device
+ ),
+ frame_true_atom_b,
+ ]
+
+ pair_mask = (
+ mask_frame_true[:, None, :, None] # if true frame is invalid
+ * mask_collinear_true[:, :, :, None] # if true frame is invalid
+ * mask_collinear_pred[:, :, :, None] # if pred frame is invalid
+ * b_true_resolved_mask[:, :, None, :] # If atom j is not resolved
+ * feats["token_pad_mask"][:, None, :, None]
+ * feats["token_pad_mask"][:, None, None, :]
+ )
+
+ token_type = feats["mol_type"]
+ token_type = token_type.repeat_interleave(multiplicity, 0)
+
+ protein_mask = (token_type == const.chain_type_ids["PROTEIN"]).float()
+ ligand_mask = (token_type == const.chain_type_ids["NONPOLYMER"]).float()
+ dna_mask = (token_type == const.chain_type_ids["DNA"]).float()
+ rna_mask = (token_type == const.chain_type_ids["RNA"]).float()
+
+ # compute different paes
+ dna_protein_mask = pair_mask * (
+ dna_mask[:, :, None] * protein_mask[:, None, :]
+ + protein_mask[:, :, None] * dna_mask[:, None, :]
+ )
+ dna_protein_mae = torch.sum(torch.abs(target_pae - pred_pae) * dna_protein_mask) / (
+ torch.sum(dna_protein_mask) + 1e-5
+ )
+ dna_protein_total = torch.sum(dna_protein_mask)
+
+ rna_protein_mask = pair_mask * (
+ rna_mask[:, :, None] * protein_mask[:, None, :]
+ + protein_mask[:, :, None] * rna_mask[:, None, :]
+ )
+ rna_protein_mae = torch.sum(torch.abs(target_pae - pred_pae) * rna_protein_mask) / (
+ torch.sum(rna_protein_mask) + 1e-5
+ )
+ rna_protein_total = torch.sum(rna_protein_mask)
+
+ ligand_protein_mask = pair_mask * (
+ ligand_mask[:, :, None] * protein_mask[:, None, :]
+ + protein_mask[:, :, None] * ligand_mask[:, None, :]
+ )
+ ligand_protein_mae = torch.sum(
+ torch.abs(target_pae - pred_pae) * ligand_protein_mask
+ ) / (torch.sum(ligand_protein_mask) + 1e-5)
+ ligand_protein_total = torch.sum(ligand_protein_mask)
+
+ dna_ligand_mask = pair_mask * (
+ dna_mask[:, :, None] * ligand_mask[:, None, :]
+ + ligand_mask[:, :, None] * dna_mask[:, None, :]
+ )
+ dna_ligand_mae = torch.sum(torch.abs(target_pae - pred_pae) * dna_ligand_mask) / (
+ torch.sum(dna_ligand_mask) + 1e-5
+ )
+ dna_ligand_total = torch.sum(dna_ligand_mask)
+
+ rna_ligand_mask = pair_mask * (
+ rna_mask[:, :, None] * ligand_mask[:, None, :]
+ + ligand_mask[:, :, None] * rna_mask[:, None, :]
+ )
+ rna_ligand_mae = torch.sum(torch.abs(target_pae - pred_pae) * rna_ligand_mask) / (
+ torch.sum(rna_ligand_mask) + 1e-5
+ )
+ rna_ligand_total = torch.sum(rna_ligand_mask)
+
+ intra_ligand_mask = pair_mask * (ligand_mask[:, :, None] * ligand_mask[:, None, :])
+ intra_ligand_mae = torch.sum(
+ torch.abs(target_pae - pred_pae) * intra_ligand_mask
+ ) / (torch.sum(intra_ligand_mask) + 1e-5)
+ intra_ligand_total = torch.sum(intra_ligand_mask)
+
+ intra_dna_mask = pair_mask * (dna_mask[:, :, None] * dna_mask[:, None, :])
+ intra_dna_mae = torch.sum(torch.abs(target_pae - pred_pae) * intra_dna_mask) / (
+ torch.sum(intra_dna_mask) + 1e-5
+ )
+ intra_dna_total = torch.sum(intra_dna_mask)
+
+ intra_rna_mask = pair_mask * (rna_mask[:, :, None] * rna_mask[:, None, :])
+ intra_rna_mae = torch.sum(torch.abs(target_pae - pred_pae) * intra_rna_mask) / (
+ torch.sum(intra_rna_mask) + 1e-5
+ )
+ intra_rna_total = torch.sum(intra_rna_mask)
+
+ chain_id = feats["asym_id"].repeat_interleave(multiplicity, 0)
+ same_chain_mask = (chain_id[:, :, None] == chain_id[:, None, :]).float()
+
+ intra_protein_mask = (
+ pair_mask
+ * same_chain_mask
+ * (protein_mask[:, :, None] * protein_mask[:, None, :])
+ )
+ intra_protein_mae = torch.sum(
+ torch.abs(target_pae - pred_pae) * intra_protein_mask
+ ) / (torch.sum(intra_protein_mask) + 1e-5)
+ intra_protein_total = torch.sum(intra_protein_mask)
+
+ protein_protein_mask = (
+ pair_mask
+ * (1 - same_chain_mask)
+ * (protein_mask[:, :, None] * protein_mask[:, None, :])
+ )
+ protein_protein_mae = torch.sum(
+ torch.abs(target_pae - pred_pae) * protein_protein_mask
+ ) / (torch.sum(protein_protein_mask) + 1e-5)
+ protein_protein_total = torch.sum(protein_protein_mask)
+
+ mae_pae_dict = {
+ "dna_protein": dna_protein_mae,
+ "rna_protein": rna_protein_mae,
+ "ligand_protein": ligand_protein_mae,
+ "dna_ligand": dna_ligand_mae,
+ "rna_ligand": rna_ligand_mae,
+ "intra_ligand": intra_ligand_mae,
+ "intra_dna": intra_dna_mae,
+ "intra_rna": intra_rna_mae,
+ "intra_protein": intra_protein_mae,
+ "protein_protein": protein_protein_mae,
+ }
+ total_pae_dict = {
+ "dna_protein": dna_protein_total,
+ "rna_protein": rna_protein_total,
+ "ligand_protein": ligand_protein_total,
+ "dna_ligand": dna_ligand_total,
+ "rna_ligand": rna_ligand_total,
+ "intra_ligand": intra_ligand_total,
+ "intra_dna": intra_dna_total,
+ "intra_rna": intra_rna_total,
+ "intra_protein": intra_protein_total,
+ "protein_protein": protein_protein_total,
+ }
+
+ return mae_pae_dict, total_pae_dict
+
+
+def weighted_minimum_rmsd(
+ pred_atom_coords,
+ feats,
+ multiplicity=1,
+ nucleotide_weight=5.0,
+ ligand_weight=10.0,
+):
+ """Compute rmsd of the aligned atom coordinates.
+
+ Parameters
+ ----------
+ pred_atom_coords : torch.Tensor
+ Predicted atom coordinates
+ feats : torch.Tensor
+ Input features
+ multiplicity : int
+ Diffusion batch size, by default 1
+
+ Returns
+ -------
+ Tensor
+ The rmsds
+ Tensor
+ The best rmsd
+
+ """
+ atom_coords = feats["coords"]
+ atom_coords = atom_coords.repeat_interleave(multiplicity, 0)
+ atom_coords = atom_coords[:, 0]
+
+ atom_mask = feats["atom_resolved_mask"]
+ atom_mask = atom_mask.repeat_interleave(multiplicity, 0)
+
+ align_weights = atom_coords.new_ones(atom_coords.shape[:2])
+ atom_type = (
+ torch.bmm(
+ feats["atom_to_token"].float(), feats["mol_type"].unsqueeze(-1).float()
+ )
+ .squeeze(-1)
+ .long()
+ )
+ atom_type = atom_type.repeat_interleave(multiplicity, 0)
+
+ align_weights = align_weights * (
+ 1
+ + nucleotide_weight
+ * (
+ torch.eq(atom_type, const.chain_type_ids["DNA"]).float()
+ + torch.eq(atom_type, const.chain_type_ids["RNA"]).float()
+ )
+ + ligand_weight
+ * torch.eq(atom_type, const.chain_type_ids["NONPOLYMER"]).float()
+ )
+
+ with torch.no_grad():
+ atom_coords_aligned_ground_truth = weighted_rigid_align(
+ atom_coords, pred_atom_coords, align_weights, mask=atom_mask
+ )
+
+ # weighted MSE loss of denoised atom positions
+ mse_loss = ((pred_atom_coords - atom_coords_aligned_ground_truth) ** 2).sum(dim=-1)
+ rmsd = torch.sqrt(
+ torch.sum(mse_loss * align_weights * atom_mask, dim=-1)
+ / torch.sum(align_weights * atom_mask, dim=-1)
+ )
+ best_rmsd = torch.min(rmsd.reshape(-1, multiplicity), dim=1).values
+
+ return rmsd, best_rmsd
+
+
+def weighted_minimum_rmsd_single(
+ pred_atom_coords,
+ atom_coords,
+ atom_mask,
+ atom_to_token,
+ mol_type,
+ nucleotide_weight=5.0,
+ ligand_weight=10.0,
+):
+ """Compute rmsd of the aligned atom coordinates.
+
+ Parameters
+ ----------
+ pred_atom_coords : torch.Tensor
+ Predicted atom coordinates
+ atom_coords: torch.Tensor
+ Ground truth atom coordinates
+ atom_mask : torch.Tensor
+ Resolved atom mask
+ atom_to_token : torch.Tensor
+ Atom to token mapping
+ mol_type : torch.Tensor
+ Atom type
+
+ Returns
+ -------
+ Tensor
+ The rmsd
+ Tensor
+ The aligned coordinates
+ Tensor
+ The aligned weights
+
+ """
+ align_weights = atom_coords.new_ones(atom_coords.shape[:2])
+ atom_type = (
+ torch.bmm(atom_to_token.float(), mol_type.unsqueeze(-1).float())
+ .squeeze(-1)
+ .long()
+ )
+
+ align_weights = align_weights * (
+ 1
+ + nucleotide_weight
+ * (
+ torch.eq(atom_type, const.chain_type_ids["DNA"]).float()
+ + torch.eq(atom_type, const.chain_type_ids["RNA"]).float()
+ )
+ + ligand_weight
+ * torch.eq(atom_type, const.chain_type_ids["NONPOLYMER"]).float()
+ )
+
+ with torch.no_grad():
+ atom_coords_aligned_ground_truth = weighted_rigid_align(
+ atom_coords, pred_atom_coords, align_weights, mask=atom_mask
+ )
+
+ # weighted MSE loss of denoised atom positions
+ mse_loss = ((pred_atom_coords - atom_coords_aligned_ground_truth) ** 2).sum(dim=-1)
+ rmsd = torch.sqrt(
+ torch.sum(mse_loss * align_weights * atom_mask, dim=-1)
+ / torch.sum(align_weights * atom_mask, dim=-1)
+ )
+ return rmsd, atom_coords_aligned_ground_truth, align_weights
diff --git a/forks/boltz/src/boltz/model/models/__init__.py b/forks/boltz/src/boltz/model/models/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/model/models/boltz1.py b/forks/boltz/src/boltz/model/models/boltz1.py
new file mode 100644
index 00000000..51889b88
--- /dev/null
+++ b/forks/boltz/src/boltz/model/models/boltz1.py
@@ -0,0 +1,1292 @@
+import gc
+import random
+from typing import Any, Optional
+
+import torch
+import torch._dynamo
+from pytorch_lightning import LightningModule
+from torch import Tensor, nn
+from torchmetrics import MeanMetric
+
+import boltz.model.layers.initialize as init
+from boltz.data import const
+from boltz.data.feature.symmetry import (
+ minimum_lddt_symmetry_coords,
+ minimum_symmetry_coords,
+)
+from boltz.model.loss.confidence import confidence_loss
+from boltz.model.loss.distogram import distogram_loss
+from boltz.model.loss.validation import (
+ compute_pae_mae,
+ compute_pde_mae,
+ compute_plddt_mae,
+ factored_lddt_loss,
+ factored_token_lddt_dist_loss,
+ weighted_minimum_rmsd,
+)
+from boltz.model.modules.confidence import ConfidenceModule
+from boltz.model.modules.diffusion import AtomDiffusion
+from boltz.model.modules.encoders import RelativePositionEncoder
+from boltz.model.modules.trunk import (
+ DistogramModule,
+ InputEmbedder,
+ MSAModule,
+ PairformerModule,
+)
+from boltz.model.modules.utils import ExponentialMovingAverage
+from boltz.model.optim.scheduler import AlphaFoldLRScheduler
+
+
+class Boltz1(LightningModule):
+ """Boltz1 model."""
+
+ def __init__( # noqa: PLR0915, C901, PLR0912
+ self,
+ atom_s: int,
+ atom_z: int,
+ token_s: int,
+ token_z: int,
+ num_bins: int,
+ training_args: dict[str, Any],
+ validation_args: dict[str, Any],
+ embedder_args: dict[str, Any],
+ msa_args: dict[str, Any],
+ pairformer_args: dict[str, Any],
+ score_model_args: dict[str, Any],
+ diffusion_process_args: dict[str, Any],
+ diffusion_loss_args: dict[str, Any],
+ confidence_model_args: dict[str, Any],
+ atom_feature_dim: int = 128,
+ confidence_prediction: bool = False,
+ confidence_imitate_trunk: bool = False,
+ alpha_pae: float = 0.0,
+ structure_prediction_training: bool = True,
+ atoms_per_window_queries: int = 32,
+ atoms_per_window_keys: int = 128,
+ compile_pairformer: bool = False,
+ compile_structure: bool = False,
+ compile_confidence: bool = False,
+ nucleotide_rmsd_weight: float = 5.0,
+ ligand_rmsd_weight: float = 10.0,
+ no_msa: bool = False,
+ no_atom_encoder: bool = False,
+ ema: bool = False,
+ ema_decay: float = 0.999,
+ min_dist: float = 2.0,
+ max_dist: float = 22.0,
+ predict_args: Optional[dict[str, Any]] = None,
+ steering_args: Optional[dict[str, Any]] = None,
+ use_kernels: bool = False,
+ ) -> None:
+ super().__init__()
+
+ self.save_hyperparameters()
+
+ self.lddt = nn.ModuleDict()
+ self.disto_lddt = nn.ModuleDict()
+ self.complex_lddt = nn.ModuleDict()
+ if confidence_prediction:
+ self.top1_lddt = nn.ModuleDict()
+ self.iplddt_top1_lddt = nn.ModuleDict()
+ self.ipde_top1_lddt = nn.ModuleDict()
+ self.pde_top1_lddt = nn.ModuleDict()
+ self.ptm_top1_lddt = nn.ModuleDict()
+ self.iptm_top1_lddt = nn.ModuleDict()
+ self.ligand_iptm_top1_lddt = nn.ModuleDict()
+ self.protein_iptm_top1_lddt = nn.ModuleDict()
+ self.avg_lddt = nn.ModuleDict()
+ self.plddt_mae = nn.ModuleDict()
+ self.pde_mae = nn.ModuleDict()
+ self.pae_mae = nn.ModuleDict()
+ for m in const.out_types + ["pocket_ligand_protein"]:
+ self.lddt[m] = MeanMetric()
+ self.disto_lddt[m] = MeanMetric()
+ self.complex_lddt[m] = MeanMetric()
+ if confidence_prediction:
+ self.top1_lddt[m] = MeanMetric()
+ self.iplddt_top1_lddt[m] = MeanMetric()
+ self.ipde_top1_lddt[m] = MeanMetric()
+ self.pde_top1_lddt[m] = MeanMetric()
+ self.ptm_top1_lddt[m] = MeanMetric()
+ self.iptm_top1_lddt[m] = MeanMetric()
+ self.ligand_iptm_top1_lddt[m] = MeanMetric()
+ self.protein_iptm_top1_lddt[m] = MeanMetric()
+ self.avg_lddt[m] = MeanMetric()
+ self.pde_mae[m] = MeanMetric()
+ self.pae_mae[m] = MeanMetric()
+ for m in const.out_single_types:
+ if confidence_prediction:
+ self.plddt_mae[m] = MeanMetric()
+ self.rmsd = MeanMetric()
+ self.best_rmsd = MeanMetric()
+
+ self.train_confidence_loss_logger = MeanMetric()
+ self.train_confidence_loss_dict_logger = nn.ModuleDict()
+ for m in [
+ "plddt_loss",
+ "resolved_loss",
+ "pde_loss",
+ "pae_loss",
+ ]:
+ self.train_confidence_loss_dict_logger[m] = MeanMetric()
+
+ self.ema = None
+ self.use_ema = ema
+ self.ema_decay = ema_decay
+
+ self.training_args = training_args
+ self.validation_args = validation_args
+ self.diffusion_loss_args = diffusion_loss_args
+ self.predict_args = predict_args
+ self.steering_args = steering_args
+
+ self.use_kernels = use_kernels
+
+ self.nucleotide_rmsd_weight = nucleotide_rmsd_weight
+ self.ligand_rmsd_weight = ligand_rmsd_weight
+
+ self.num_bins = num_bins
+ self.min_dist = min_dist
+ self.max_dist = max_dist
+ self.is_pairformer_compiled = False
+
+ # Input projections
+ s_input_dim = (
+ token_s + 2 * const.num_tokens + 1 + len(const.pocket_contact_info)
+ )
+ self.s_init = nn.Linear(s_input_dim, token_s, bias=False)
+ self.z_init_1 = nn.Linear(s_input_dim, token_z, bias=False)
+ self.z_init_2 = nn.Linear(s_input_dim, token_z, bias=False)
+
+ # Input embeddings
+ full_embedder_args = {
+ "atom_s": atom_s,
+ "atom_z": atom_z,
+ "token_s": token_s,
+ "token_z": token_z,
+ "atoms_per_window_queries": atoms_per_window_queries,
+ "atoms_per_window_keys": atoms_per_window_keys,
+ "atom_feature_dim": atom_feature_dim,
+ "no_atom_encoder": no_atom_encoder,
+ **embedder_args,
+ }
+ self.input_embedder = InputEmbedder(**full_embedder_args)
+ self.rel_pos = RelativePositionEncoder(token_z)
+ self.token_bonds = nn.Linear(1, token_z, bias=False)
+
+ # Normalization layers
+ self.s_norm = nn.LayerNorm(token_s)
+ self.z_norm = nn.LayerNorm(token_z)
+
+ # Recycling projections
+ self.s_recycle = nn.Linear(token_s, token_s, bias=False)
+ self.z_recycle = nn.Linear(token_z, token_z, bias=False)
+ init.gating_init_(self.s_recycle.weight)
+ init.gating_init_(self.z_recycle.weight)
+
+ # Pairwise stack
+ self.no_msa = no_msa
+ if not no_msa:
+ self.msa_module = MSAModule(
+ token_z=token_z,
+ s_input_dim=s_input_dim,
+ **msa_args,
+ )
+ self.pairformer_module = PairformerModule(token_s, token_z, **pairformer_args)
+ if compile_pairformer:
+ # Big models hit the default cache limit (8)
+ self.is_pairformer_compiled = True
+ torch._dynamo.config.cache_size_limit = 512
+ torch._dynamo.config.accumulated_cache_size_limit = 512
+ self.pairformer_module = torch.compile(
+ self.pairformer_module,
+ dynamic=False,
+ fullgraph=False,
+ )
+
+ # Output modules
+ use_accumulate_token_repr = (
+ confidence_prediction
+ and "use_s_diffusion" in confidence_model_args
+ and confidence_model_args["use_s_diffusion"]
+ )
+ self.structure_module = AtomDiffusion(
+ score_model_args={
+ "token_z": token_z,
+ "token_s": token_s,
+ "atom_z": atom_z,
+ "atom_s": atom_s,
+ "atoms_per_window_queries": atoms_per_window_queries,
+ "atoms_per_window_keys": atoms_per_window_keys,
+ "atom_feature_dim": atom_feature_dim,
+ **score_model_args,
+ },
+ compile_score=compile_structure,
+ accumulate_token_repr=use_accumulate_token_repr,
+ **diffusion_process_args,
+ )
+ self.distogram_module = DistogramModule(token_z, num_bins)
+ self.confidence_prediction = confidence_prediction
+ self.alpha_pae = alpha_pae
+
+ self.structure_prediction_training = structure_prediction_training
+ self.confidence_imitate_trunk = confidence_imitate_trunk
+ if self.confidence_prediction:
+ if self.confidence_imitate_trunk:
+ self.confidence_module = ConfidenceModule(
+ token_s,
+ token_z,
+ compute_pae=alpha_pae > 0,
+ imitate_trunk=True,
+ pairformer_args=pairformer_args,
+ full_embedder_args=full_embedder_args,
+ msa_args=msa_args,
+ **confidence_model_args,
+ )
+ else:
+ self.confidence_module = ConfidenceModule(
+ token_s,
+ token_z,
+ compute_pae=alpha_pae > 0,
+ **confidence_model_args,
+ )
+ if compile_confidence:
+ self.confidence_module = torch.compile(
+ self.confidence_module, dynamic=False, fullgraph=False
+ )
+
+ # Remove grad from weights they are not trained for ddp
+ if not structure_prediction_training:
+ for name, param in self.named_parameters():
+ if name.split(".")[0] != "confidence_module":
+ param.requires_grad = False
+
+ def setup(self, stage: str) -> None:
+ """Set the model for training, validation and inference."""
+ if stage == "predict" and not (
+ torch.cuda.is_available()
+ and torch.cuda.get_device_properties(torch.device("cuda")).major >= 8.0 # noqa: PLR2004
+ ):
+ self.use_kernels = False
+
+ def forward(
+ self,
+ feats: dict[str, Tensor],
+ recycling_steps: int = 0,
+ num_sampling_steps: Optional[int] = None,
+ multiplicity_diffusion_train: int = 1,
+ diffusion_samples: int = 1,
+ max_parallel_samples: Optional[int] = None,
+ run_confidence_sequentially: bool = False,
+ ) -> dict[str, Tensor]:
+ dict_out = {}
+
+ # Compute input embeddings
+ with torch.set_grad_enabled(
+ self.training and self.structure_prediction_training
+ ):
+ s_inputs = self.input_embedder(feats)
+
+ # Initialize the sequence and pairwise embeddings
+ s_init = self.s_init(s_inputs)
+ z_init = (
+ self.z_init_1(s_inputs)[:, :, None]
+ + self.z_init_2(s_inputs)[:, None, :]
+ )
+ relative_position_encoding = self.rel_pos(feats)
+ z_init = z_init + relative_position_encoding
+ z_init = z_init + self.token_bonds(feats["token_bonds"].float())
+
+ # Perform rounds of the pairwise stack
+ s = torch.zeros_like(s_init)
+ z = torch.zeros_like(z_init)
+
+ # Compute pairwise mask
+ mask = feats["token_pad_mask"].float()
+ pair_mask = mask[:, :, None] * mask[:, None, :]
+
+ for i in range(recycling_steps + 1):
+ with torch.set_grad_enabled(self.training and (i == recycling_steps)):
+ # Fixes an issue with unused parameters in autocast
+ if (
+ self.training
+ and (i == recycling_steps)
+ and torch.is_autocast_enabled()
+ ):
+ torch.clear_autocast_cache()
+
+ # Apply recycling
+ s = s_init + self.s_recycle(self.s_norm(s))
+ z = z_init + self.z_recycle(self.z_norm(z))
+
+ # Compute pairwise stack
+ if not self.no_msa:
+ z = z + self.msa_module(
+ z, s_inputs, feats, use_kernels=self.use_kernels
+ )
+
+ # Revert to uncompiled version for validation
+ if self.is_pairformer_compiled and not self.training:
+ pairformer_module = self.pairformer_module._orig_mod # noqa: SLF001
+ else:
+ pairformer_module = self.pairformer_module
+
+ s, z = pairformer_module(
+ s,
+ z,
+ mask=mask,
+ pair_mask=pair_mask,
+ use_kernels=self.use_kernels,
+ )
+
+ pdistogram = self.distogram_module(z)
+ dict_out = {
+ "pdistogram": pdistogram,
+ "s": s,
+ "z": z,
+ }
+
+ # Compute structure module
+ if self.training and self.structure_prediction_training:
+ dict_out.update(
+ self.structure_module(
+ s_trunk=s,
+ z_trunk=z,
+ s_inputs=s_inputs,
+ feats=feats,
+ relative_position_encoding=relative_position_encoding,
+ multiplicity=multiplicity_diffusion_train,
+ )
+ )
+
+ if (not self.training) or self.confidence_prediction:
+ dict_out.update(
+ self.structure_module.sample(
+ s_trunk=s,
+ z_trunk=z,
+ s_inputs=s_inputs,
+ feats=feats,
+ relative_position_encoding=relative_position_encoding,
+ num_sampling_steps=num_sampling_steps,
+ atom_mask=feats["atom_pad_mask"],
+ multiplicity=diffusion_samples,
+ max_parallel_samples=max_parallel_samples,
+ train_accumulate_token_repr=self.training,
+ steering_args=self.steering_args,
+ )
+ )
+
+ if self.confidence_prediction:
+ dict_out.update(
+ self.confidence_module(
+ s_inputs=s_inputs.detach(),
+ s=s.detach(),
+ z=z.detach(),
+ s_diffusion=(
+ dict_out["diff_token_repr"]
+ if self.confidence_module.use_s_diffusion
+ else None
+ ),
+ x_pred=dict_out["sample_atom_coords"].detach(),
+ feats=feats,
+ pred_distogram_logits=dict_out["pdistogram"].detach(),
+ multiplicity=diffusion_samples,
+ run_sequentially=run_confidence_sequentially,
+ use_kernels=self.use_kernels,
+ )
+ )
+ if self.confidence_prediction and self.confidence_module.use_s_diffusion:
+ dict_out.pop("diff_token_repr", None)
+ return dict_out
+
+ def get_true_coordinates(
+ self,
+ batch,
+ out,
+ diffusion_samples,
+ symmetry_correction,
+ lddt_minimization=True,
+ ):
+ if symmetry_correction:
+ min_coords_routine = (
+ minimum_lddt_symmetry_coords
+ if lddt_minimization
+ else minimum_symmetry_coords
+ )
+ true_coords = []
+ true_coords_resolved_mask = []
+ rmsds, best_rmsds = [], []
+ for idx in range(batch["token_index"].shape[0]):
+ best_rmsd = float("inf")
+ for rep in range(diffusion_samples):
+ i = idx * diffusion_samples + rep
+ best_true_coords, rmsd, best_true_coords_resolved_mask = (
+ min_coords_routine(
+ coords=out["sample_atom_coords"][i : i + 1],
+ feats=batch,
+ index_batch=idx,
+ nucleotide_weight=self.nucleotide_rmsd_weight,
+ ligand_weight=self.ligand_rmsd_weight,
+ )
+ )
+ rmsds.append(rmsd)
+ true_coords.append(best_true_coords)
+ true_coords_resolved_mask.append(best_true_coords_resolved_mask)
+ if rmsd < best_rmsd:
+ best_rmsd = rmsd
+ best_rmsds.append(best_rmsd)
+ true_coords = torch.cat(true_coords, dim=0)
+ true_coords_resolved_mask = torch.cat(true_coords_resolved_mask, dim=0)
+ else:
+ true_coords = (
+ batch["coords"].squeeze(1).repeat_interleave(diffusion_samples, 0)
+ )
+
+ true_coords_resolved_mask = batch["atom_resolved_mask"].repeat_interleave(
+ diffusion_samples, 0
+ )
+ rmsds, best_rmsds = weighted_minimum_rmsd(
+ out["sample_atom_coords"],
+ batch,
+ multiplicity=diffusion_samples,
+ nucleotide_weight=self.nucleotide_rmsd_weight,
+ ligand_weight=self.ligand_rmsd_weight,
+ )
+
+ return true_coords, rmsds, best_rmsds, true_coords_resolved_mask
+
+ def training_step(self, batch: dict[str, Tensor], batch_idx: int) -> Tensor:
+ # Sample recycling steps
+ recycling_steps = random.randint(0, self.training_args.recycling_steps)
+
+ # Compute the forward pass
+ out = self(
+ feats=batch,
+ recycling_steps=recycling_steps,
+ num_sampling_steps=self.training_args.sampling_steps,
+ multiplicity_diffusion_train=self.training_args.diffusion_multiplicity,
+ diffusion_samples=self.training_args.diffusion_samples,
+ )
+
+ # Compute losses
+ if self.structure_prediction_training:
+ disto_loss, _ = distogram_loss(
+ out,
+ batch,
+ )
+ try:
+ diffusion_loss_dict = self.structure_module.compute_loss(
+ batch,
+ out,
+ multiplicity=self.training_args.diffusion_multiplicity,
+ **self.diffusion_loss_args,
+ )
+ except Exception as e:
+ print(f"Skipping batch {batch_idx} due to error: {e}")
+ return None
+
+ else:
+ disto_loss = 0.0
+ diffusion_loss_dict = {"loss": 0.0, "loss_breakdown": {}}
+
+ if self.confidence_prediction:
+ # confidence model symmetry correction
+ true_coords, _, _, true_coords_resolved_mask = self.get_true_coordinates(
+ batch,
+ out,
+ diffusion_samples=self.training_args.diffusion_samples,
+ symmetry_correction=self.training_args.symmetry_correction,
+ )
+
+ confidence_loss_dict = confidence_loss(
+ out,
+ batch,
+ true_coords,
+ true_coords_resolved_mask,
+ alpha_pae=self.alpha_pae,
+ multiplicity=self.training_args.diffusion_samples,
+ )
+ else:
+ confidence_loss_dict = {
+ "loss": torch.tensor(0.0).to(batch["token_index"].device),
+ "loss_breakdown": {},
+ }
+
+ # Aggregate losses
+ loss = (
+ self.training_args.confidence_loss_weight * confidence_loss_dict["loss"]
+ + self.training_args.diffusion_loss_weight * diffusion_loss_dict["loss"]
+ + self.training_args.distogram_loss_weight * disto_loss
+ )
+ # Log losses
+ self.log("train/distogram_loss", disto_loss)
+ self.log("train/diffusion_loss", diffusion_loss_dict["loss"])
+ for k, v in diffusion_loss_dict["loss_breakdown"].items():
+ self.log(f"train/{k}", v)
+
+ if self.confidence_prediction:
+ self.train_confidence_loss_logger.update(
+ confidence_loss_dict["loss"].detach()
+ )
+
+ for k in self.train_confidence_loss_dict_logger.keys():
+ self.train_confidence_loss_dict_logger[k].update(
+ confidence_loss_dict["loss_breakdown"][k].detach()
+ if torch.is_tensor(confidence_loss_dict["loss_breakdown"][k])
+ else confidence_loss_dict["loss_breakdown"][k]
+ )
+ self.log("train/loss", loss)
+ self.training_log()
+ return loss
+
+ def training_log(self):
+ self.log("train/grad_norm", self.gradient_norm(self), prog_bar=False)
+ self.log("train/param_norm", self.parameter_norm(self), prog_bar=False)
+
+ lr = self.trainer.optimizers[0].param_groups[0]["lr"]
+ self.log("lr", lr, prog_bar=False)
+
+ self.log(
+ "train/grad_norm_msa_module",
+ self.gradient_norm(self.msa_module),
+ prog_bar=False,
+ )
+ self.log(
+ "train/param_norm_msa_module",
+ self.parameter_norm(self.msa_module),
+ prog_bar=False,
+ )
+
+ self.log(
+ "train/grad_norm_pairformer_module",
+ self.gradient_norm(self.pairformer_module),
+ prog_bar=False,
+ )
+ self.log(
+ "train/param_norm_pairformer_module",
+ self.parameter_norm(self.pairformer_module),
+ prog_bar=False,
+ )
+
+ self.log(
+ "train/grad_norm_structure_module",
+ self.gradient_norm(self.structure_module),
+ prog_bar=False,
+ )
+ self.log(
+ "train/param_norm_structure_module",
+ self.parameter_norm(self.structure_module),
+ prog_bar=False,
+ )
+
+ if self.confidence_prediction:
+ self.log(
+ "train/grad_norm_confidence_module",
+ self.gradient_norm(self.confidence_module),
+ prog_bar=False,
+ )
+ self.log(
+ "train/param_norm_confidence_module",
+ self.parameter_norm(self.confidence_module),
+ prog_bar=False,
+ )
+
+ def on_train_epoch_end(self):
+ self.log(
+ "train/confidence_loss",
+ self.train_confidence_loss_logger,
+ prog_bar=False,
+ on_step=False,
+ on_epoch=True,
+ )
+ for k, v in self.train_confidence_loss_dict_logger.items():
+ self.log(f"train/{k}", v, prog_bar=False, on_step=False, on_epoch=True)
+
+ def gradient_norm(self, module) -> float:
+ # Only compute over parameters that are being trained
+ parameters = filter(lambda p: p.requires_grad, module.parameters())
+ parameters = filter(lambda p: p.grad is not None, parameters)
+ norm = torch.tensor([p.grad.norm(p=2) ** 2 for p in parameters]).sum().sqrt()
+ return norm
+
+ def parameter_norm(self, module) -> float:
+ # Only compute over parameters that are being trained
+ parameters = filter(lambda p: p.requires_grad, module.parameters())
+ norm = torch.tensor([p.norm(p=2) ** 2 for p in parameters]).sum().sqrt()
+ return norm
+
+ def validation_step(self, batch: dict[str, Tensor], batch_idx: int):
+ # Compute the forward pass
+ n_samples = self.validation_args.diffusion_samples
+ try:
+ out = self(
+ batch,
+ recycling_steps=self.validation_args.recycling_steps,
+ num_sampling_steps=self.validation_args.sampling_steps,
+ diffusion_samples=n_samples,
+ run_confidence_sequentially=self.validation_args.run_confidence_sequentially,
+ )
+
+ except RuntimeError as e: # catch out of memory exceptions
+ if "out of memory" in str(e):
+ print("| WARNING: ran out of memory, skipping batch")
+ torch.cuda.empty_cache()
+ gc.collect()
+ return
+ else:
+ raise e
+
+ try:
+ # Compute distogram LDDT
+ boundaries = torch.linspace(2, 22.0, 63)
+ lower = torch.tensor([1.0])
+ upper = torch.tensor([22.0 + 5.0])
+ exp_boundaries = torch.cat((lower, boundaries, upper))
+ mid_points = ((exp_boundaries[:-1] + exp_boundaries[1:]) / 2).to(
+ out["pdistogram"]
+ )
+
+ # Compute predicted dists
+ preds = out["pdistogram"]
+ pred_softmax = torch.softmax(preds, dim=-1)
+ pred_softmax = pred_softmax.argmax(dim=-1)
+ pred_softmax = torch.nn.functional.one_hot(
+ pred_softmax, num_classes=preds.shape[-1]
+ )
+ pred_dist = (pred_softmax * mid_points).sum(dim=-1)
+ true_center = batch["disto_center"]
+ true_dists = torch.cdist(true_center, true_center)
+
+ # Compute lddt's
+ batch["token_disto_mask"] = batch["token_disto_mask"]
+ disto_lddt_dict, disto_total_dict = factored_token_lddt_dist_loss(
+ feats=batch,
+ true_d=true_dists,
+ pred_d=pred_dist,
+ )
+
+ true_coords, rmsds, best_rmsds, true_coords_resolved_mask = (
+ self.get_true_coordinates(
+ batch=batch,
+ out=out,
+ diffusion_samples=n_samples,
+ symmetry_correction=self.validation_args.symmetry_correction,
+ )
+ )
+
+ all_lddt_dict, all_total_dict = factored_lddt_loss(
+ feats=batch,
+ atom_mask=true_coords_resolved_mask,
+ true_atom_coords=true_coords,
+ pred_atom_coords=out["sample_atom_coords"],
+ multiplicity=n_samples,
+ )
+ except RuntimeError as e: # catch out of memory exceptions
+ if "out of memory" in str(e):
+ print("| WARNING: ran out of memory, skipping batch")
+ torch.cuda.empty_cache()
+ gc.collect()
+ return
+ else:
+ raise e
+ # if the multiplicity used is > 1 then we take the best lddt of the different samples
+ # AF3 combines this with the confidence based filtering
+ best_lddt_dict, best_total_dict = {}, {}
+ best_complex_lddt_dict, best_complex_total_dict = {}, {}
+ B = true_coords.shape[0] // n_samples
+ if n_samples > 1:
+ # NOTE: we can change the way we aggregate the lddt
+ complex_total = 0
+ complex_lddt = 0
+ for key in all_lddt_dict.keys():
+ complex_lddt += all_lddt_dict[key] * all_total_dict[key]
+ complex_total += all_total_dict[key]
+ complex_lddt /= complex_total + 1e-7
+ best_complex_idx = complex_lddt.reshape(-1, n_samples).argmax(dim=1)
+ for key in all_lddt_dict:
+ best_idx = all_lddt_dict[key].reshape(-1, n_samples).argmax(dim=1)
+ best_lddt_dict[key] = all_lddt_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), best_idx
+ ]
+ best_total_dict[key] = all_total_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), best_idx
+ ]
+ best_complex_lddt_dict[key] = all_lddt_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), best_complex_idx
+ ]
+ best_complex_total_dict[key] = all_total_dict[key].reshape(
+ -1, n_samples
+ )[torch.arange(B), best_complex_idx]
+ else:
+ best_lddt_dict = all_lddt_dict
+ best_total_dict = all_total_dict
+ best_complex_lddt_dict = all_lddt_dict
+ best_complex_total_dict = all_total_dict
+
+ # Filtering based on confidence
+ if self.confidence_prediction and n_samples > 1:
+ # note: for now we don't have pae predictions so have to use pLDDT instead of pTM
+ # also, while AF3 differentiates the best prediction per confidence type we are currently not doing it
+ # consider this in the future as well as weighing the different pLLDT types before aggregation
+ mae_plddt_dict, total_mae_plddt_dict = compute_plddt_mae(
+ pred_atom_coords=out["sample_atom_coords"],
+ feats=batch,
+ true_atom_coords=true_coords,
+ pred_lddt=out["plddt"],
+ true_coords_resolved_mask=true_coords_resolved_mask,
+ multiplicity=n_samples,
+ )
+ mae_pde_dict, total_mae_pde_dict = compute_pde_mae(
+ pred_atom_coords=out["sample_atom_coords"],
+ feats=batch,
+ true_atom_coords=true_coords,
+ pred_pde=out["pde"],
+ true_coords_resolved_mask=true_coords_resolved_mask,
+ multiplicity=n_samples,
+ )
+ mae_pae_dict, total_mae_pae_dict = compute_pae_mae(
+ pred_atom_coords=out["sample_atom_coords"],
+ feats=batch,
+ true_atom_coords=true_coords,
+ pred_pae=out["pae"],
+ true_coords_resolved_mask=true_coords_resolved_mask,
+ multiplicity=n_samples,
+ )
+
+ plddt = out["complex_plddt"].reshape(-1, n_samples)
+ top1_idx = plddt.argmax(dim=1)
+ iplddt = out["complex_iplddt"].reshape(-1, n_samples)
+ iplddt_top1_idx = iplddt.argmax(dim=1)
+ pde = out["complex_pde"].reshape(-1, n_samples)
+ pde_top1_idx = pde.argmin(dim=1)
+ ipde = out["complex_ipde"].reshape(-1, n_samples)
+ ipde_top1_idx = ipde.argmin(dim=1)
+ ptm = out["ptm"].reshape(-1, n_samples)
+ ptm_top1_idx = ptm.argmax(dim=1)
+ iptm = out["iptm"].reshape(-1, n_samples)
+ iptm_top1_idx = iptm.argmax(dim=1)
+ ligand_iptm = out["ligand_iptm"].reshape(-1, n_samples)
+ ligand_iptm_top1_idx = ligand_iptm.argmax(dim=1)
+ protein_iptm = out["protein_iptm"].reshape(-1, n_samples)
+ protein_iptm_top1_idx = protein_iptm.argmax(dim=1)
+
+ for key in all_lddt_dict:
+ top1_lddt = all_lddt_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), top1_idx
+ ]
+ top1_total = all_total_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), top1_idx
+ ]
+ iplddt_top1_lddt = all_lddt_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), iplddt_top1_idx
+ ]
+ iplddt_top1_total = all_total_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), iplddt_top1_idx
+ ]
+ pde_top1_lddt = all_lddt_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), pde_top1_idx
+ ]
+ pde_top1_total = all_total_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), pde_top1_idx
+ ]
+ ipde_top1_lddt = all_lddt_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), ipde_top1_idx
+ ]
+ ipde_top1_total = all_total_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), ipde_top1_idx
+ ]
+ ptm_top1_lddt = all_lddt_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), ptm_top1_idx
+ ]
+ ptm_top1_total = all_total_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), ptm_top1_idx
+ ]
+ iptm_top1_lddt = all_lddt_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), iptm_top1_idx
+ ]
+ iptm_top1_total = all_total_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), iptm_top1_idx
+ ]
+ ligand_iptm_top1_lddt = all_lddt_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), ligand_iptm_top1_idx
+ ]
+ ligand_iptm_top1_total = all_total_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), ligand_iptm_top1_idx
+ ]
+ protein_iptm_top1_lddt = all_lddt_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), protein_iptm_top1_idx
+ ]
+ protein_iptm_top1_total = all_total_dict[key].reshape(-1, n_samples)[
+ torch.arange(B), protein_iptm_top1_idx
+ ]
+
+ self.top1_lddt[key].update(top1_lddt, top1_total)
+ self.iplddt_top1_lddt[key].update(iplddt_top1_lddt, iplddt_top1_total)
+ self.pde_top1_lddt[key].update(pde_top1_lddt, pde_top1_total)
+ self.ipde_top1_lddt[key].update(ipde_top1_lddt, ipde_top1_total)
+ self.ptm_top1_lddt[key].update(ptm_top1_lddt, ptm_top1_total)
+ self.iptm_top1_lddt[key].update(iptm_top1_lddt, iptm_top1_total)
+ self.ligand_iptm_top1_lddt[key].update(
+ ligand_iptm_top1_lddt, ligand_iptm_top1_total
+ )
+ self.protein_iptm_top1_lddt[key].update(
+ protein_iptm_top1_lddt, protein_iptm_top1_total
+ )
+
+ self.avg_lddt[key].update(all_lddt_dict[key], all_total_dict[key])
+ self.pde_mae[key].update(mae_pde_dict[key], total_mae_pde_dict[key])
+ self.pae_mae[key].update(mae_pae_dict[key], total_mae_pae_dict[key])
+
+ for key in mae_plddt_dict:
+ self.plddt_mae[key].update(
+ mae_plddt_dict[key], total_mae_plddt_dict[key]
+ )
+
+ for m in const.out_types:
+ if m == "ligand_protein":
+ if torch.any(
+ batch["pocket_feature"][
+ :, :, const.pocket_contact_info["POCKET"]
+ ].bool()
+ ):
+ self.lddt["pocket_ligand_protein"].update(
+ best_lddt_dict[m], best_total_dict[m]
+ )
+ self.disto_lddt["pocket_ligand_protein"].update(
+ disto_lddt_dict[m], disto_total_dict[m]
+ )
+ self.complex_lddt["pocket_ligand_protein"].update(
+ best_complex_lddt_dict[m], best_complex_total_dict[m]
+ )
+ else:
+ self.lddt["ligand_protein"].update(
+ best_lddt_dict[m], best_total_dict[m]
+ )
+ self.disto_lddt["ligand_protein"].update(
+ disto_lddt_dict[m], disto_total_dict[m]
+ )
+ self.complex_lddt["ligand_protein"].update(
+ best_complex_lddt_dict[m], best_complex_total_dict[m]
+ )
+ else:
+ self.lddt[m].update(best_lddt_dict[m], best_total_dict[m])
+ self.disto_lddt[m].update(disto_lddt_dict[m], disto_total_dict[m])
+ self.complex_lddt[m].update(
+ best_complex_lddt_dict[m], best_complex_total_dict[m]
+ )
+ self.rmsd.update(rmsds)
+ self.best_rmsd.update(best_rmsds)
+
+ def on_validation_epoch_end(self):
+ avg_lddt = {}
+ avg_disto_lddt = {}
+ avg_complex_lddt = {}
+ if self.confidence_prediction:
+ avg_top1_lddt = {}
+ avg_iplddt_top1_lddt = {}
+ avg_pde_top1_lddt = {}
+ avg_ipde_top1_lddt = {}
+ avg_ptm_top1_lddt = {}
+ avg_iptm_top1_lddt = {}
+ avg_ligand_iptm_top1_lddt = {}
+ avg_protein_iptm_top1_lddt = {}
+
+ avg_avg_lddt = {}
+ avg_mae_plddt = {}
+ avg_mae_pde = {}
+ avg_mae_pae = {}
+
+ for m in const.out_types + ["pocket_ligand_protein"]:
+ avg_lddt[m] = self.lddt[m].compute()
+ avg_lddt[m] = 0.0 if torch.isnan(avg_lddt[m]) else avg_lddt[m].item()
+ self.lddt[m].reset()
+ self.log(f"val/lddt_{m}", avg_lddt[m], prog_bar=False, sync_dist=True)
+
+ avg_disto_lddt[m] = self.disto_lddt[m].compute()
+ avg_disto_lddt[m] = (
+ 0.0 if torch.isnan(avg_disto_lddt[m]) else avg_disto_lddt[m].item()
+ )
+ self.disto_lddt[m].reset()
+ self.log(
+ f"val/disto_lddt_{m}", avg_disto_lddt[m], prog_bar=False, sync_dist=True
+ )
+ avg_complex_lddt[m] = self.complex_lddt[m].compute()
+ avg_complex_lddt[m] = (
+ 0.0 if torch.isnan(avg_complex_lddt[m]) else avg_complex_lddt[m].item()
+ )
+ self.complex_lddt[m].reset()
+ self.log(
+ f"val/complex_lddt_{m}",
+ avg_complex_lddt[m],
+ prog_bar=False,
+ sync_dist=True,
+ )
+ if self.confidence_prediction:
+ avg_top1_lddt[m] = self.top1_lddt[m].compute()
+ avg_top1_lddt[m] = (
+ 0.0 if torch.isnan(avg_top1_lddt[m]) else avg_top1_lddt[m].item()
+ )
+ self.top1_lddt[m].reset()
+ self.log(
+ f"val/top1_lddt_{m}",
+ avg_top1_lddt[m],
+ prog_bar=False,
+ sync_dist=True,
+ )
+ avg_iplddt_top1_lddt[m] = self.iplddt_top1_lddt[m].compute()
+ avg_iplddt_top1_lddt[m] = (
+ 0.0
+ if torch.isnan(avg_iplddt_top1_lddt[m])
+ else avg_iplddt_top1_lddt[m].item()
+ )
+ self.iplddt_top1_lddt[m].reset()
+ self.log(
+ f"val/iplddt_top1_lddt_{m}",
+ avg_iplddt_top1_lddt[m],
+ prog_bar=False,
+ sync_dist=True,
+ )
+ avg_pde_top1_lddt[m] = self.pde_top1_lddt[m].compute()
+ avg_pde_top1_lddt[m] = (
+ 0.0
+ if torch.isnan(avg_pde_top1_lddt[m])
+ else avg_pde_top1_lddt[m].item()
+ )
+ self.pde_top1_lddt[m].reset()
+ self.log(
+ f"val/pde_top1_lddt_{m}",
+ avg_pde_top1_lddt[m],
+ prog_bar=False,
+ sync_dist=True,
+ )
+ avg_ipde_top1_lddt[m] = self.ipde_top1_lddt[m].compute()
+ avg_ipde_top1_lddt[m] = (
+ 0.0
+ if torch.isnan(avg_ipde_top1_lddt[m])
+ else avg_ipde_top1_lddt[m].item()
+ )
+ self.ipde_top1_lddt[m].reset()
+ self.log(
+ f"val/ipde_top1_lddt_{m}",
+ avg_ipde_top1_lddt[m],
+ prog_bar=False,
+ sync_dist=True,
+ )
+ avg_ptm_top1_lddt[m] = self.ptm_top1_lddt[m].compute()
+ avg_ptm_top1_lddt[m] = (
+ 0.0
+ if torch.isnan(avg_ptm_top1_lddt[m])
+ else avg_ptm_top1_lddt[m].item()
+ )
+ self.ptm_top1_lddt[m].reset()
+ self.log(
+ f"val/ptm_top1_lddt_{m}",
+ avg_ptm_top1_lddt[m],
+ prog_bar=False,
+ sync_dist=True,
+ )
+ avg_iptm_top1_lddt[m] = self.iptm_top1_lddt[m].compute()
+ avg_iptm_top1_lddt[m] = (
+ 0.0
+ if torch.isnan(avg_iptm_top1_lddt[m])
+ else avg_iptm_top1_lddt[m].item()
+ )
+ self.iptm_top1_lddt[m].reset()
+ self.log(
+ f"val/iptm_top1_lddt_{m}",
+ avg_iptm_top1_lddt[m],
+ prog_bar=False,
+ sync_dist=True,
+ )
+
+ avg_ligand_iptm_top1_lddt[m] = self.ligand_iptm_top1_lddt[m].compute()
+ avg_ligand_iptm_top1_lddt[m] = (
+ 0.0
+ if torch.isnan(avg_ligand_iptm_top1_lddt[m])
+ else avg_ligand_iptm_top1_lddt[m].item()
+ )
+ self.ligand_iptm_top1_lddt[m].reset()
+ self.log(
+ f"val/ligand_iptm_top1_lddt_{m}",
+ avg_ligand_iptm_top1_lddt[m],
+ prog_bar=False,
+ sync_dist=True,
+ )
+
+ avg_protein_iptm_top1_lddt[m] = self.protein_iptm_top1_lddt[m].compute()
+ avg_protein_iptm_top1_lddt[m] = (
+ 0.0
+ if torch.isnan(avg_protein_iptm_top1_lddt[m])
+ else avg_protein_iptm_top1_lddt[m].item()
+ )
+ self.protein_iptm_top1_lddt[m].reset()
+ self.log(
+ f"val/protein_iptm_top1_lddt_{m}",
+ avg_protein_iptm_top1_lddt[m],
+ prog_bar=False,
+ sync_dist=True,
+ )
+
+ avg_avg_lddt[m] = self.avg_lddt[m].compute()
+ avg_avg_lddt[m] = (
+ 0.0 if torch.isnan(avg_avg_lddt[m]) else avg_avg_lddt[m].item()
+ )
+ self.avg_lddt[m].reset()
+ self.log(
+ f"val/avg_lddt_{m}", avg_avg_lddt[m], prog_bar=False, sync_dist=True
+ )
+ avg_mae_pde[m] = self.pde_mae[m].compute().item()
+ self.pde_mae[m].reset()
+ self.log(
+ f"val/MAE_pde_{m}",
+ avg_mae_pde[m],
+ prog_bar=False,
+ sync_dist=True,
+ )
+ avg_mae_pae[m] = self.pae_mae[m].compute().item()
+ self.pae_mae[m].reset()
+ self.log(
+ f"val/MAE_pae_{m}",
+ avg_mae_pae[m],
+ prog_bar=False,
+ sync_dist=True,
+ )
+
+ for m in const.out_single_types:
+ if self.confidence_prediction:
+ avg_mae_plddt[m] = self.plddt_mae[m].compute().item()
+ self.plddt_mae[m].reset()
+ self.log(
+ f"val/MAE_plddt_{m}",
+ avg_mae_plddt[m],
+ prog_bar=False,
+ sync_dist=True,
+ )
+
+ overall_disto_lddt = sum(
+ avg_disto_lddt[m] * w for (m, w) in const.out_types_weights.items()
+ ) / sum(const.out_types_weights.values())
+ self.log("val/disto_lddt", overall_disto_lddt, prog_bar=True, sync_dist=True)
+
+ overall_lddt = sum(
+ avg_lddt[m] * w for (m, w) in const.out_types_weights.items()
+ ) / sum(const.out_types_weights.values())
+ self.log("val/lddt", overall_lddt, prog_bar=True, sync_dist=True)
+
+ overall_complex_lddt = sum(
+ avg_complex_lddt[m] * w for (m, w) in const.out_types_weights.items()
+ ) / sum(const.out_types_weights.values())
+ self.log(
+ "val/complex_lddt", overall_complex_lddt, prog_bar=True, sync_dist=True
+ )
+
+ if self.confidence_prediction:
+ overall_top1_lddt = sum(
+ avg_top1_lddt[m] * w for (m, w) in const.out_types_weights.items()
+ ) / sum(const.out_types_weights.values())
+ self.log("val/top1_lddt", overall_top1_lddt, prog_bar=True, sync_dist=True)
+
+ overall_iplddt_top1_lddt = sum(
+ avg_iplddt_top1_lddt[m] * w
+ for (m, w) in const.out_types_weights.items()
+ ) / sum(const.out_types_weights.values())
+ self.log(
+ "val/iplddt_top1_lddt",
+ overall_iplddt_top1_lddt,
+ prog_bar=True,
+ sync_dist=True,
+ )
+
+ overall_pde_top1_lddt = sum(
+ avg_pde_top1_lddt[m] * w for (m, w) in const.out_types_weights.items()
+ ) / sum(const.out_types_weights.values())
+ self.log(
+ "val/pde_top1_lddt",
+ overall_pde_top1_lddt,
+ prog_bar=True,
+ sync_dist=True,
+ )
+
+ overall_ipde_top1_lddt = sum(
+ avg_ipde_top1_lddt[m] * w for (m, w) in const.out_types_weights.items()
+ ) / sum(const.out_types_weights.values())
+ self.log(
+ "val/ipde_top1_lddt",
+ overall_ipde_top1_lddt,
+ prog_bar=True,
+ sync_dist=True,
+ )
+
+ overall_ptm_top1_lddt = sum(
+ avg_ptm_top1_lddt[m] * w for (m, w) in const.out_types_weights.items()
+ ) / sum(const.out_types_weights.values())
+ self.log(
+ "val/ptm_top1_lddt",
+ overall_ptm_top1_lddt,
+ prog_bar=True,
+ sync_dist=True,
+ )
+
+ overall_iptm_top1_lddt = sum(
+ avg_iptm_top1_lddt[m] * w for (m, w) in const.out_types_weights.items()
+ ) / sum(const.out_types_weights.values())
+ self.log(
+ "val/iptm_top1_lddt",
+ overall_iptm_top1_lddt,
+ prog_bar=True,
+ sync_dist=True,
+ )
+
+ overall_avg_lddt = sum(
+ avg_avg_lddt[m] * w for (m, w) in const.out_types_weights.items()
+ ) / sum(const.out_types_weights.values())
+ self.log("val/avg_lddt", overall_avg_lddt, prog_bar=True, sync_dist=True)
+
+ self.log("val/rmsd", self.rmsd.compute(), prog_bar=True, sync_dist=True)
+ self.rmsd.reset()
+
+ self.log(
+ "val/best_rmsd", self.best_rmsd.compute(), prog_bar=True, sync_dist=True
+ )
+ self.best_rmsd.reset()
+
+ def predict_step(self, batch: Any, batch_idx: int, dataloader_idx: int = 0) -> Any:
+ try:
+ out = self(
+ batch,
+ recycling_steps=self.predict_args["recycling_steps"],
+ num_sampling_steps=self.predict_args["sampling_steps"],
+ diffusion_samples=self.predict_args["diffusion_samples"],
+ max_parallel_samples=self.predict_args["diffusion_samples"],
+ run_confidence_sequentially=True,
+ )
+ pred_dict = {"exception": False}
+ pred_dict["masks"] = batch["atom_pad_mask"]
+ pred_dict["coords"] = out["sample_atom_coords"]
+ pred_dict["s"] = out["s"]
+ pred_dict["z"] = out["z"]
+ if self.predict_args.get("write_confidence_summary", True):
+ pred_dict["confidence_score"] = (
+ 4 * out["complex_plddt"]
+ + (
+ out["iptm"]
+ if not torch.allclose(
+ out["iptm"], torch.zeros_like(out["iptm"])
+ )
+ else out["ptm"]
+ )
+ ) / 5
+ for key in [
+ "ptm",
+ "iptm",
+ "ligand_iptm",
+ "protein_iptm",
+ "pair_chains_iptm",
+ "complex_plddt",
+ "complex_iplddt",
+ "complex_pde",
+ "complex_ipde",
+ "plddt",
+ ]:
+ pred_dict[key] = out[key]
+ if self.predict_args.get("write_full_pae", True):
+ pred_dict["pae"] = out["pae"]
+ if self.predict_args.get("write_full_pde", False):
+ pred_dict["pde"] = out["pde"]
+ return pred_dict
+
+ except RuntimeError as e: # catch out of memory exceptions
+ if "out of memory" in str(e):
+ print("| WARNING: ran out of memory, skipping batch")
+ torch.cuda.empty_cache()
+ gc.collect()
+ return {"exception": True}
+ else:
+ raise
+
+ def configure_optimizers(self):
+ """Configure the optimizer."""
+
+ if self.structure_prediction_training:
+ parameters = [p for p in self.parameters() if p.requires_grad]
+ else:
+ parameters = [
+ p for p in self.confidence_module.parameters() if p.requires_grad
+ ] + [
+ p
+ for p in self.structure_module.out_token_feat_update.parameters()
+ if p.requires_grad
+ ]
+
+ optimizer = torch.optim.Adam(
+ parameters,
+ betas=(self.training_args.adam_beta_1, self.training_args.adam_beta_2),
+ eps=self.training_args.adam_eps,
+ lr=self.training_args.base_lr,
+ )
+ if self.training_args.lr_scheduler == "af3":
+ scheduler = AlphaFoldLRScheduler(
+ optimizer,
+ base_lr=self.training_args.base_lr,
+ max_lr=self.training_args.max_lr,
+ warmup_no_steps=self.training_args.lr_warmup_no_steps,
+ start_decay_after_n_steps=self.training_args.lr_start_decay_after_n_steps,
+ decay_every_n_steps=self.training_args.lr_decay_every_n_steps,
+ decay_factor=self.training_args.lr_decay_factor,
+ )
+ return [optimizer], [{"scheduler": scheduler, "interval": "step"}]
+
+ return optimizer
+
+ def on_save_checkpoint(self, checkpoint: dict[str, Any]) -> None:
+ if self.use_ema:
+ checkpoint["ema"] = self.ema.state_dict()
+
+ def on_load_checkpoint(self, checkpoint: dict[str, Any]) -> None:
+ if self.use_ema and "ema" in checkpoint:
+ self.ema = ExponentialMovingAverage(
+ parameters=self.parameters(), decay=self.ema_decay
+ )
+ if self.ema.compatible(checkpoint["ema"]["shadow_params"]):
+ self.ema.load_state_dict(checkpoint["ema"], device=torch.device("cpu"))
+ else:
+ self.ema = None
+ print(
+ "Warning: EMA state not loaded due to incompatible model parameters."
+ )
+
+ def on_train_start(self):
+ if self.use_ema and self.ema is None:
+ self.ema = ExponentialMovingAverage(
+ parameters=self.parameters(), decay=self.ema_decay
+ )
+ elif self.use_ema:
+ self.ema.to(self.device)
+
+ def on_train_epoch_start(self) -> None:
+ if self.use_ema:
+ self.ema.restore(self.parameters())
+
+ def on_train_batch_end(self, outputs, batch: Any, batch_idx: int) -> None:
+ # Updates EMA parameters after optimizer.step()
+ if self.use_ema:
+ self.ema.update(self.parameters())
+
+ def prepare_eval(self) -> None:
+ if self.use_ema and self.ema is None:
+ self.ema = ExponentialMovingAverage(
+ parameters=self.parameters(), decay=self.ema_decay
+ )
+
+ if self.use_ema:
+ self.ema.store(self.parameters())
+ self.ema.copy_to(self.parameters())
+
+ def on_validation_start(self):
+ self.prepare_eval()
+
+ def on_predict_start(self) -> None:
+ self.prepare_eval()
+
+ def on_test_start(self) -> None:
+ self.prepare_eval()
diff --git a/forks/boltz/src/boltz/model/models/boltz2.py b/forks/boltz/src/boltz/model/models/boltz2.py
new file mode 100644
index 00000000..d42f3400
--- /dev/null
+++ b/forks/boltz/src/boltz/model/models/boltz2.py
@@ -0,0 +1,1255 @@
+import gc
+from typing import Any, Optional
+
+import numpy as np
+import torch
+import torch._dynamo
+from pytorch_lightning import Callback, LightningModule
+from torch import Tensor, nn
+from torchmetrics import MeanMetric
+
+import boltz.model.layers.initialize as init
+from boltz.data import const
+from boltz.data.mol import (
+ minimum_lddt_symmetry_coords,
+)
+from boltz.model.layers.pairformer import PairformerModule
+from boltz.model.loss.bfactor import bfactor_loss_fn
+from boltz.model.loss.confidencev2 import (
+ confidence_loss,
+)
+from boltz.model.loss.distogramv2 import distogram_loss
+from boltz.model.modules.affinity import AffinityModule
+from boltz.model.modules.confidencev2 import ConfidenceModule
+from boltz.model.modules.diffusion_conditioning import DiffusionConditioning
+from boltz.model.modules.diffusionv2 import AtomDiffusion
+from boltz.model.modules.encodersv2 import RelativePositionEncoder
+from boltz.model.modules.trunkv2 import (
+ BFactorModule,
+ ContactConditioning,
+ DistogramModule,
+ InputEmbedder,
+ MSAModule,
+ TemplateModule,
+ TemplateV2Module,
+)
+from boltz.model.optim.ema import EMA
+from boltz.model.optim.scheduler import AlphaFoldLRScheduler
+
+
+class Boltz2(LightningModule):
+ """Boltz2 model."""
+
+ def __init__(
+ self,
+ atom_s: int,
+ atom_z: int,
+ token_s: int,
+ token_z: int,
+ num_bins: int,
+ training_args: dict[str, Any],
+ validation_args: dict[str, Any],
+ embedder_args: dict[str, Any],
+ msa_args: dict[str, Any],
+ pairformer_args: dict[str, Any],
+ score_model_args: dict[str, Any],
+ diffusion_process_args: dict[str, Any],
+ diffusion_loss_args: dict[str, Any],
+ confidence_model_args: Optional[dict[str, Any]] = None,
+ affinity_model_args: Optional[dict[str, Any]] = None,
+ affinity_model_args1: Optional[dict[str, Any]] = None,
+ affinity_model_args2: Optional[dict[str, Any]] = None,
+ validators: Any = None,
+ num_val_datasets: int = 1,
+ atom_feature_dim: int = 128,
+ template_args: Optional[dict] = None,
+ confidence_prediction: bool = True,
+ affinity_prediction: bool = False,
+ affinity_ensemble: bool = False,
+ affinity_mw_correction: bool = True,
+ run_trunk_and_structure: bool = True,
+ skip_run_structure: bool = False,
+ token_level_confidence: bool = True,
+ alpha_pae: float = 0.0,
+ structure_prediction_training: bool = True,
+ validate_structure: bool = True,
+ atoms_per_window_queries: int = 32,
+ atoms_per_window_keys: int = 128,
+ compile_pairformer: bool = False,
+ compile_structure: bool = False,
+ compile_confidence: bool = False,
+ compile_affinity: bool = False,
+ compile_msa: bool = False,
+ exclude_ions_from_lddt: bool = False,
+ ema: bool = False,
+ ema_decay: float = 0.999,
+ min_dist: float = 2.0,
+ max_dist: float = 22.0,
+ predict_args: Optional[dict[str, Any]] = None,
+ fix_sym_check: bool = False,
+ cyclic_pos_enc: bool = False,
+ aggregate_distogram: bool = True,
+ bond_type_feature: bool = False,
+ use_no_atom_char: bool = False,
+ no_random_recycling_training: bool = False,
+ use_atom_backbone_feat: bool = False,
+ use_residue_feats_atoms: bool = False,
+ conditioning_cutoff_min: float = 4.0,
+ conditioning_cutoff_max: float = 20.0,
+ steering_args: Optional[dict] = None,
+ use_templates: bool = False,
+ compile_templates: bool = False,
+ predict_bfactor: bool = False,
+ log_loss_every_steps: int = 50,
+ checkpoint_diffusion_conditioning: bool = False,
+ use_templates_v2: bool = False,
+ use_kernels: bool = False,
+ ) -> None:
+ super().__init__()
+ self.save_hyperparameters(ignore=["validators"])
+
+ # No random recycling
+ self.no_random_recycling_training = no_random_recycling_training
+
+ if validate_structure:
+ # Late init at setup time
+ self.val_group_mapper = {} # maps a dataset index to a validation group name
+ self.validator_mapper = {} # maps a dataset index to a validator
+
+ # Validators for each dataset keep track of all metrics,
+ # compute validation, aggregate results and log
+ self.validators = nn.ModuleList(validators)
+
+ self.num_val_datasets = num_val_datasets
+ self.log_loss_every_steps = log_loss_every_steps
+
+ # EMA
+ self.use_ema = ema
+ self.ema_decay = ema_decay
+
+ # Arguments
+ self.training_args = training_args
+ self.validation_args = validation_args
+ self.diffusion_loss_args = diffusion_loss_args
+ self.predict_args = predict_args
+ self.steering_args = steering_args
+
+ # Training metrics
+ if validate_structure:
+ self.train_confidence_loss_logger = MeanMetric()
+ self.train_confidence_loss_dict_logger = nn.ModuleDict()
+ for m in [
+ "plddt_loss",
+ "resolved_loss",
+ "pde_loss",
+ "pae_loss",
+ ]:
+ self.train_confidence_loss_dict_logger[m] = MeanMetric()
+
+ self.exclude_ions_from_lddt = exclude_ions_from_lddt
+
+ # Distogram
+ self.num_bins = num_bins
+ self.min_dist = min_dist
+ self.max_dist = max_dist
+ self.aggregate_distogram = aggregate_distogram
+
+ # Trunk
+ self.is_pairformer_compiled = False
+ self.is_msa_compiled = False
+ self.is_template_compiled = False
+
+ # Kernels
+ self.use_kernels = use_kernels
+
+ # Input embeddings
+ full_embedder_args = {
+ "atom_s": atom_s,
+ "atom_z": atom_z,
+ "token_s": token_s,
+ "token_z": token_z,
+ "atoms_per_window_queries": atoms_per_window_queries,
+ "atoms_per_window_keys": atoms_per_window_keys,
+ "atom_feature_dim": atom_feature_dim,
+ "use_no_atom_char": use_no_atom_char,
+ "use_atom_backbone_feat": use_atom_backbone_feat,
+ "use_residue_feats_atoms": use_residue_feats_atoms,
+ **embedder_args,
+ }
+ self.input_embedder = InputEmbedder(**full_embedder_args)
+
+ self.s_init = nn.Linear(token_s, token_s, bias=False)
+ self.z_init_1 = nn.Linear(token_s, token_z, bias=False)
+ self.z_init_2 = nn.Linear(token_s, token_z, bias=False)
+
+ self.rel_pos = RelativePositionEncoder(
+ token_z, fix_sym_check=fix_sym_check, cyclic_pos_enc=cyclic_pos_enc
+ )
+
+ self.token_bonds = nn.Linear(1, token_z, bias=False)
+ self.bond_type_feature = bond_type_feature
+ if bond_type_feature:
+ self.token_bonds_type = nn.Embedding(len(const.bond_types) + 1, token_z)
+
+ self.contact_conditioning = ContactConditioning(
+ token_z=token_z,
+ cutoff_min=conditioning_cutoff_min,
+ cutoff_max=conditioning_cutoff_max,
+ )
+
+ # Normalization layers
+ self.s_norm = nn.LayerNorm(token_s)
+ self.z_norm = nn.LayerNorm(token_z)
+
+ # Recycling projections
+ self.s_recycle = nn.Linear(token_s, token_s, bias=False)
+ self.z_recycle = nn.Linear(token_z, token_z, bias=False)
+ init.gating_init_(self.s_recycle.weight)
+ init.gating_init_(self.z_recycle.weight)
+
+ # Set compile rules
+ # Big models hit the default cache limit (8)
+ torch._dynamo.config.cache_size_limit = 512 # noqa: SLF001
+ torch._dynamo.config.accumulated_cache_size_limit = 512 # noqa: SLF001
+
+ # Pairwise stack
+ self.use_templates = use_templates
+ if use_templates:
+ if use_templates_v2:
+ self.template_module = TemplateV2Module(token_z, **template_args)
+ else:
+ self.template_module = TemplateModule(token_z, **template_args)
+ if compile_templates:
+ self.is_template_compiled = True
+ self.template_module = torch.compile(
+ self.template_module,
+ dynamic=False,
+ fullgraph=False,
+ )
+
+ self.msa_module = MSAModule(
+ token_z=token_z,
+ token_s=token_s,
+ **msa_args,
+ )
+ if compile_msa:
+ self.is_msa_compiled = True
+ self.msa_module = torch.compile(
+ self.msa_module,
+ dynamic=False,
+ fullgraph=False,
+ )
+ self.pairformer_module = PairformerModule(token_s, token_z, **pairformer_args)
+ if compile_pairformer:
+ self.is_pairformer_compiled = True
+ self.pairformer_module = torch.compile(
+ self.pairformer_module,
+ dynamic=False,
+ fullgraph=False,
+ )
+
+ self.checkpoint_diffusion_conditioning = checkpoint_diffusion_conditioning
+ self.diffusion_conditioning = DiffusionConditioning(
+ token_s=token_s,
+ token_z=token_z,
+ atom_s=atom_s,
+ atom_z=atom_z,
+ atoms_per_window_queries=atoms_per_window_queries,
+ atoms_per_window_keys=atoms_per_window_keys,
+ atom_encoder_depth=score_model_args["atom_encoder_depth"],
+ atom_encoder_heads=score_model_args["atom_encoder_heads"],
+ token_transformer_depth=score_model_args["token_transformer_depth"],
+ token_transformer_heads=score_model_args["token_transformer_heads"],
+ atom_decoder_depth=score_model_args["atom_decoder_depth"],
+ atom_decoder_heads=score_model_args["atom_decoder_heads"],
+ atom_feature_dim=atom_feature_dim,
+ conditioning_transition_layers=score_model_args[
+ "conditioning_transition_layers"
+ ],
+ use_no_atom_char=use_no_atom_char,
+ use_atom_backbone_feat=use_atom_backbone_feat,
+ use_residue_feats_atoms=use_residue_feats_atoms,
+ )
+
+ # Output modules
+ self.structure_module = AtomDiffusion(
+ score_model_args={
+ "token_s": token_s,
+ "atom_s": atom_s,
+ "atoms_per_window_queries": atoms_per_window_queries,
+ "atoms_per_window_keys": atoms_per_window_keys,
+ **score_model_args,
+ },
+ compile_score=compile_structure,
+ **diffusion_process_args,
+ )
+ self.distogram_module = DistogramModule(
+ token_z,
+ num_bins,
+ )
+ self.predict_bfactor = predict_bfactor
+ if predict_bfactor:
+ self.bfactor_module = BFactorModule(token_s, num_bins)
+
+ self.confidence_prediction = confidence_prediction
+ self.affinity_prediction = affinity_prediction
+ self.affinity_ensemble = affinity_ensemble
+ self.affinity_mw_correction = affinity_mw_correction
+ self.run_trunk_and_structure = run_trunk_and_structure
+ self.skip_run_structure = skip_run_structure
+ self.token_level_confidence = token_level_confidence
+ self.alpha_pae = alpha_pae
+ self.structure_prediction_training = structure_prediction_training
+
+ if self.confidence_prediction:
+ self.confidence_module = ConfidenceModule(
+ token_s,
+ token_z,
+ token_level_confidence=token_level_confidence,
+ bond_type_feature=bond_type_feature,
+ fix_sym_check=fix_sym_check,
+ cyclic_pos_enc=cyclic_pos_enc,
+ conditioning_cutoff_min=conditioning_cutoff_min,
+ conditioning_cutoff_max=conditioning_cutoff_max,
+ **confidence_model_args,
+ )
+ if compile_confidence:
+ self.confidence_module = torch.compile(
+ self.confidence_module, dynamic=False, fullgraph=False
+ )
+
+ if self.affinity_prediction:
+ if self.affinity_ensemble:
+ self.affinity_module1 = AffinityModule(
+ token_s,
+ token_z,
+ **affinity_model_args1,
+ )
+ self.affinity_module2 = AffinityModule(
+ token_s,
+ token_z,
+ **affinity_model_args2,
+ )
+ if compile_affinity:
+ self.affinity_module1 = torch.compile(
+ self.affinity_module1, dynamic=False, fullgraph=False
+ )
+ self.affinity_module2 = torch.compile(
+ self.affinity_module2, dynamic=False, fullgraph=False
+ )
+ else:
+ self.affinity_module = AffinityModule(
+ token_s,
+ token_z,
+ **affinity_model_args,
+ )
+ if compile_affinity:
+ self.affinity_module = torch.compile(
+ self.affinity_module, dynamic=False, fullgraph=False
+ )
+
+ # Remove grad from weights they are not trained for ddp
+ if not structure_prediction_training:
+ for name, param in self.named_parameters():
+ if (
+ name.split(".")[0] not in ["confidence_module", "affinity_module"]
+ and "out_token_feat_update" not in name
+ ):
+ param.requires_grad = False
+
+ def setup(self, stage: str) -> None:
+ """Set the model for training, validation and inference."""
+ if stage == "predict" and not (
+ torch.cuda.is_available()
+ and torch.cuda.get_device_properties(torch.device("cuda")).major >= 8.0 # noqa: PLR2004
+ ):
+ self.use_kernels = False
+
+ if (
+ stage != "predict"
+ and hasattr(self.trainer, "datamodule")
+ and self.trainer.datamodule
+ and self.validate_structure
+ ):
+ self.val_group_mapper.update(self.trainer.datamodule.val_group_mapper)
+
+ l1 = len(self.val_group_mapper)
+ l2 = self.num_val_datasets
+ msg = (
+ f"Number of validation datasets num_val_datasets={l2} "
+ f"does not match the number of val_group_mapper entries={l1}."
+ )
+ assert l1 == l2, msg
+
+ # Map an index to a validator, and double check val names
+ # match from datamodule
+ all_validator_names = []
+ for validator in self.validators:
+ for val_name in validator.val_names:
+ msg = f"Validator {val_name} duplicated in validators."
+ assert val_name not in all_validator_names, msg
+ all_validator_names.append(val_name)
+ for val_idx, val_group in self.val_group_mapper.items():
+ if val_name == val_group["label"]:
+ self.validator_mapper[val_idx] = validator
+
+ msg = "Mismatch between validator names and val_group_mapper values."
+ assert set(all_validator_names) == {
+ x["label"] for x in self.val_group_mapper.values()
+ }, msg
+
+ def forward(
+ self,
+ feats: dict[str, Tensor],
+ recycling_steps: int = 0,
+ num_sampling_steps: Optional[int] = None,
+ multiplicity_diffusion_train: int = 1,
+ diffusion_samples: int = 1,
+ max_parallel_samples: Optional[int] = None,
+ run_confidence_sequentially: bool = False,
+ ) -> dict[str, Tensor]:
+ with torch.set_grad_enabled(
+ self.training and self.structure_prediction_training
+ ):
+ s_inputs = self.input_embedder(feats)
+
+ # Initialize the sequence embeddings
+ s_init = self.s_init(s_inputs)
+
+ # Initialize pairwise embeddings
+ z_init = (
+ self.z_init_1(s_inputs)[:, :, None]
+ + self.z_init_2(s_inputs)[:, None, :]
+ )
+ relative_position_encoding = self.rel_pos(feats)
+ z_init = z_init + relative_position_encoding
+ z_init = z_init + self.token_bonds(feats["token_bonds"].float())
+ if self.bond_type_feature:
+ z_init = z_init + self.token_bonds_type(feats["type_bonds"].long())
+ z_init = z_init + self.contact_conditioning(feats)
+
+ # Perform rounds of the pairwise stack
+ s = torch.zeros_like(s_init)
+ z = torch.zeros_like(z_init)
+
+ # Compute pairwise mask
+ mask = feats["token_pad_mask"].float()
+ pair_mask = mask[:, :, None] * mask[:, None, :]
+ if self.run_trunk_and_structure:
+ for i in range(recycling_steps + 1):
+ with torch.set_grad_enabled(
+ self.training
+ and self.structure_prediction_training
+ and (i == recycling_steps)
+ ):
+ # Issue with unused parameters in autocast
+ if (
+ self.training
+ and (i == recycling_steps)
+ and torch.is_autocast_enabled()
+ ):
+ torch.clear_autocast_cache()
+
+ # Apply recycling
+ s = s_init + self.s_recycle(self.s_norm(s))
+ z = z_init + self.z_recycle(self.z_norm(z))
+
+ # Compute pairwise stack
+ if self.use_templates:
+ if self.is_template_compiled and not self.training:
+ template_module = self.template_module._orig_mod # noqa: SLF001
+ else:
+ template_module = self.template_module
+
+ z = z + template_module(
+ z, feats, pair_mask, use_kernels=self.use_kernels
+ )
+
+ if self.is_msa_compiled and not self.training:
+ msa_module = self.msa_module._orig_mod # noqa: SLF001
+ else:
+ msa_module = self.msa_module
+
+ z = z + msa_module(
+ z, s_inputs, feats, use_kernels=self.use_kernels
+ )
+
+ # Revert to uncompiled version for validation
+ if self.is_pairformer_compiled and not self.training:
+ pairformer_module = self.pairformer_module._orig_mod # noqa: SLF001
+ else:
+ pairformer_module = self.pairformer_module
+
+ s, z = pairformer_module(
+ s,
+ z,
+ mask=mask,
+ pair_mask=pair_mask,
+ use_kernels=self.use_kernels,
+ )
+
+ pdistogram = self.distogram_module(z)
+ dict_out = {
+ "pdistogram": pdistogram,
+ "s": s,
+ "z": z,
+ }
+
+ if (
+ self.run_trunk_and_structure
+ and ((not self.training) or self.confidence_prediction)
+ and (not self.skip_run_structure)
+ ):
+ if self.checkpoint_diffusion_conditioning and self.training:
+ # TODO decide whether this should be with bf16 or not
+ q, c, to_keys, atom_enc_bias, atom_dec_bias, token_trans_bias = (
+ torch.utils.checkpoint.checkpoint(
+ self.diffusion_conditioning,
+ s,
+ z,
+ relative_position_encoding,
+ feats,
+ )
+ )
+ else:
+ q, c, to_keys, atom_enc_bias, atom_dec_bias, token_trans_bias = (
+ self.diffusion_conditioning(
+ s_trunk=s,
+ z_trunk=z,
+ relative_position_encoding=relative_position_encoding,
+ feats=feats,
+ )
+ )
+ diffusion_conditioning = {
+ "q": q,
+ "c": c,
+ "to_keys": to_keys,
+ "atom_enc_bias": atom_enc_bias,
+ "atom_dec_bias": atom_dec_bias,
+ "token_trans_bias": token_trans_bias,
+ }
+
+ with torch.autocast("cuda", enabled=False):
+ struct_out = self.structure_module.sample(
+ s_trunk=s.float(),
+ s_inputs=s_inputs.float(),
+ feats=feats,
+ num_sampling_steps=num_sampling_steps,
+ atom_mask=feats["atom_pad_mask"].float(),
+ multiplicity=diffusion_samples,
+ max_parallel_samples=max_parallel_samples,
+ steering_args=self.steering_args,
+ diffusion_conditioning=diffusion_conditioning,
+ )
+ dict_out.update(struct_out)
+
+ if self.predict_bfactor:
+ pbfactor = self.bfactor_module(s)
+ dict_out["pbfactor"] = pbfactor
+
+ if self.training and self.confidence_prediction:
+ assert len(feats["coords"].shape) == 4
+ assert feats["coords"].shape[1] == 1, (
+ "Only one conformation is supported for confidence"
+ )
+
+ # Compute structure module
+ if self.training and self.structure_prediction_training:
+ atom_coords = feats["coords"]
+ B, K, L = atom_coords.shape[0:3]
+ assert K in (
+ multiplicity_diffusion_train,
+ 1,
+ ) # TODO make check somewhere else, expand to m % N == 0, m > N
+ atom_coords = atom_coords.reshape(B * K, L, 3)
+ atom_coords = atom_coords.repeat_interleave(
+ multiplicity_diffusion_train // K, 0
+ )
+ feats["coords"] = atom_coords # (multiplicity, L, 3)
+ assert len(feats["coords"].shape) == 3
+
+ with torch.autocast("cuda", enabled=False):
+ struct_out = self.structure_module(
+ s_trunk=s.float(),
+ s_inputs=s_inputs.float(),
+ feats=feats,
+ multiplicity=multiplicity_diffusion_train,
+ diffusion_conditioning=diffusion_conditioning,
+ )
+ dict_out.update(struct_out)
+
+ elif self.training:
+ feats["coords"] = feats["coords"].squeeze(1)
+ assert len(feats["coords"].shape) == 3
+
+ if self.confidence_prediction:
+ dict_out.update(
+ self.confidence_module(
+ s_inputs=s_inputs.detach(),
+ s=s.detach(),
+ z=z.detach(),
+ x_pred=(
+ dict_out["sample_atom_coords"].detach()
+ if not self.skip_run_structure
+ else feats["coords"].repeat_interleave(diffusion_samples, 0)
+ ),
+ feats=feats,
+ pred_distogram_logits=(
+ dict_out["pdistogram"][
+ :, :, :, 0
+ ].detach() # TODO only implemented for 1 distogram
+ ),
+ multiplicity=diffusion_samples,
+ run_sequentially=run_confidence_sequentially,
+ use_kernels=self.use_kernels,
+ )
+ )
+
+ if self.affinity_prediction:
+ pad_token_mask = feats["token_pad_mask"][0]
+ rec_mask = feats["mol_type"][0] == 0
+ rec_mask = rec_mask * pad_token_mask
+ lig_mask = feats["affinity_token_mask"][0].to(torch.bool)
+ lig_mask = lig_mask * pad_token_mask
+ cross_pair_mask = (
+ lig_mask[:, None] * rec_mask[None, :]
+ + rec_mask[:, None] * lig_mask[None, :]
+ + lig_mask[:, None] * lig_mask[None, :]
+ )
+ z_affinity = z * cross_pair_mask[None, :, :, None]
+
+ argsort = torch.argsort(dict_out["iptm"], descending=True)
+ best_idx = argsort[0].item()
+ coords_affinity = dict_out["sample_atom_coords"].detach()[best_idx][
+ None, None
+ ]
+ s_inputs = self.input_embedder(feats, affinity=True)
+
+ with torch.autocast("cuda", enabled=False):
+ if self.affinity_ensemble:
+ dict_out_affinity1 = self.affinity_module1(
+ s_inputs=s_inputs.detach(),
+ z=z_affinity.detach(),
+ x_pred=coords_affinity,
+ feats=feats,
+ multiplicity=1,
+ use_kernels=self.use_kernels,
+ )
+
+ dict_out_affinity1["affinity_probability_binary"] = (
+ torch.nn.functional.sigmoid(
+ dict_out_affinity1["affinity_logits_binary"]
+ )
+ )
+ dict_out_affinity2 = self.affinity_module2(
+ s_inputs=s_inputs.detach(),
+ z=z_affinity.detach(),
+ x_pred=coords_affinity,
+ feats=feats,
+ multiplicity=1,
+ use_kernels=self.use_kernels,
+ )
+ dict_out_affinity2["affinity_probability_binary"] = (
+ torch.nn.functional.sigmoid(
+ dict_out_affinity2["affinity_logits_binary"]
+ )
+ )
+
+ dict_out_affinity_ensemble = {
+ "affinity_pred_value": (
+ dict_out_affinity1["affinity_pred_value"]
+ + dict_out_affinity2["affinity_pred_value"]
+ )
+ / 2,
+ "affinity_probability_binary": (
+ dict_out_affinity1["affinity_probability_binary"]
+ + dict_out_affinity2["affinity_probability_binary"]
+ )
+ / 2,
+ }
+
+ dict_out_affinity1 = {
+ "affinity_pred_value1": dict_out_affinity1[
+ "affinity_pred_value"
+ ],
+ "affinity_probability_binary1": dict_out_affinity1[
+ "affinity_probability_binary"
+ ],
+ }
+ dict_out_affinity2 = {
+ "affinity_pred_value2": dict_out_affinity2[
+ "affinity_pred_value"
+ ],
+ "affinity_probability_binary2": dict_out_affinity2[
+ "affinity_probability_binary"
+ ],
+ }
+ if self.affinity_mw_correction:
+ model_coef = 1.03525938
+ mw_coef = -0.59992683
+ bias = 2.83288489
+ mw = feats["affinity_mw"][0] ** 0.3
+ dict_out_affinity_ensemble["affinity_pred_value"] = (
+ model_coef
+ * dict_out_affinity_ensemble["affinity_pred_value"]
+ + mw_coef * mw
+ + bias
+ )
+
+ dict_out.update(dict_out_affinity_ensemble)
+ dict_out.update(dict_out_affinity1)
+ dict_out.update(dict_out_affinity2)
+ else:
+ dict_out_affinity = self.affinity_module(
+ s_inputs=s_inputs.detach(),
+ z=z_affinity.detach(),
+ x_pred=coords_affinity,
+ feats=feats,
+ multiplicity=1,
+ use_kernels=self.use_kernels,
+ )
+ dict_out.update(
+ {
+ "affinity_pred_value": dict_out_affinity[
+ "affinity_pred_value"
+ ],
+ "affinity_probability_binary": torch.nn.functional.sigmoid(
+ dict_out_affinity["affinity_logits_binary"]
+ ),
+ }
+ )
+
+ return dict_out
+
+ def get_true_coordinates(
+ self,
+ batch: dict[str, Tensor],
+ out: dict[str, Tensor],
+ diffusion_samples: int,
+ symmetry_correction: bool,
+ expand_to_diffusion_samples: bool = True,
+ ):
+ if symmetry_correction:
+ msg = "expand_to_diffusion_samples must be true for symmetry correction."
+ assert expand_to_diffusion_samples, msg
+
+ return_dict = {}
+
+ assert batch["coords"].shape[0] == 1, (
+ f"Validation is not supported for batch sizes={batch['coords'].shape[0]}"
+ )
+
+ if symmetry_correction:
+ true_coords = []
+ true_coords_resolved_mask = []
+ for idx in range(batch["token_index"].shape[0]):
+ for rep in range(diffusion_samples):
+ i = idx * diffusion_samples + rep
+ best_true_coords, best_true_coords_resolved_mask = (
+ minimum_lddt_symmetry_coords(
+ coords=out["sample_atom_coords"][i : i + 1],
+ feats=batch,
+ index_batch=idx,
+ )
+ )
+ true_coords.append(best_true_coords)
+ true_coords_resolved_mask.append(best_true_coords_resolved_mask)
+
+ true_coords = torch.cat(true_coords, dim=0)
+ true_coords_resolved_mask = torch.cat(true_coords_resolved_mask, dim=0)
+ true_coords = true_coords.unsqueeze(1)
+
+ true_coords_resolved_mask = true_coords_resolved_mask
+
+ return_dict["true_coords"] = true_coords
+ return_dict["true_coords_resolved_mask"] = true_coords_resolved_mask
+ return_dict["rmsds"] = 0
+ return_dict["best_rmsd_recall"] = 0
+
+ else:
+ K, L = batch["coords"].shape[1:3]
+
+ true_coords_resolved_mask = batch["atom_resolved_mask"]
+ true_coords = batch["coords"].squeeze(0)
+ if expand_to_diffusion_samples:
+ true_coords = true_coords.repeat((diffusion_samples, 1, 1)).reshape(
+ diffusion_samples, K, L, 3
+ )
+
+ true_coords_resolved_mask = true_coords_resolved_mask.repeat_interleave(
+ diffusion_samples, dim=0
+ ) # since all masks are the same across conformers and diffusion samples, can just repeat S times
+ else:
+ true_coords_resolved_mask = true_coords_resolved_mask.squeeze(0)
+
+ return_dict["true_coords"] = true_coords
+ return_dict["true_coords_resolved_mask"] = true_coords_resolved_mask
+ return_dict["rmsds"] = 0
+ return_dict["best_rmsd_recall"] = 0
+ return_dict["best_rmsd_precision"] = 0
+
+ return return_dict
+
+ def training_step(self, batch: dict[str, Tensor], batch_idx: int) -> Tensor:
+ # Sample recycling steps
+ if self.no_random_recycling_training:
+ recycling_steps = self.training_args.recycling_steps
+ else:
+ rgn = np.random.default_rng(self.global_step)
+ recycling_steps = rgn.integers(
+ 0, self.training_args.recycling_steps + 1
+ ).item()
+
+ if self.training_args.get("sampling_steps_random", None) is not None:
+ rgn_samplng_steps = np.random.default_rng(self.global_step)
+ sampling_steps = rgn_samplng_steps.choice(
+ self.training_args.sampling_steps_random
+ )
+ else:
+ sampling_steps = self.training_args.sampling_steps
+
+ # Compute the forward pass
+ out = self(
+ feats=batch,
+ recycling_steps=recycling_steps,
+ num_sampling_steps=sampling_steps,
+ multiplicity_diffusion_train=self.training_args.diffusion_multiplicity,
+ diffusion_samples=self.training_args.diffusion_samples,
+ )
+
+ # Compute losses
+ if self.structure_prediction_training:
+ disto_loss, _ = distogram_loss(
+ out,
+ batch,
+ aggregate_distogram=self.aggregate_distogram,
+ )
+ try:
+ diffusion_loss_dict = self.structure_module.compute_loss(
+ batch,
+ out,
+ multiplicity=self.training_args.diffusion_multiplicity,
+ **self.diffusion_loss_args,
+ )
+ except Exception as e:
+ print(f"Skipping batch {batch_idx} due to error: {e}")
+ return None
+
+ if self.predict_bfactor:
+ bfactor_loss = bfactor_loss_fn(out, batch)
+ else:
+ bfactor_loss = 0.0
+
+ else:
+ disto_loss = 0.0
+ bfactor_loss = 0.0
+ diffusion_loss_dict = {"loss": 0.0, "loss_breakdown": {}}
+
+ if self.confidence_prediction:
+ try:
+ # confidence model symmetry correction
+ return_dict = self.get_true_coordinates(
+ batch,
+ out,
+ diffusion_samples=self.training_args.diffusion_samples,
+ symmetry_correction=self.training_args.symmetry_correction,
+ )
+ except Exception as e:
+ print(f"Skipping batch with id {batch['pdb_id']} due to error: {e}")
+ return None
+
+ true_coords = return_dict["true_coords"]
+ true_coords_resolved_mask = return_dict["true_coords_resolved_mask"]
+
+ # TODO remove once multiple conformers are supported
+ K = true_coords.shape[1]
+ assert K == 1, (
+ f"Confidence_prediction is not supported for num_ensembles_val={K}."
+ )
+
+ # For now, just take the only conformer.
+ true_coords = true_coords.squeeze(1) # (S, L, 3)
+ batch["frames_idx"] = batch["frames_idx"].squeeze(
+ 1
+ ) # remove conformer dimension
+ batch["frame_resolved_mask"] = batch["frame_resolved_mask"].squeeze(
+ 1
+ ) # remove conformer dimension
+
+ confidence_loss_dict = confidence_loss(
+ out,
+ batch,
+ true_coords,
+ true_coords_resolved_mask,
+ token_level_confidence=self.token_level_confidence,
+ alpha_pae=self.alpha_pae,
+ multiplicity=self.training_args.diffusion_samples,
+ )
+
+ else:
+ confidence_loss_dict = {
+ "loss": torch.tensor(0.0, device=batch["token_index"].device),
+ "loss_breakdown": {},
+ }
+
+ # Aggregate losses
+ # NOTE: we already have an implicit weight in the losses induced by dataset sampling
+ # NOTE: this logic works only for datasets with confidence labels
+ loss = (
+ self.training_args.confidence_loss_weight * confidence_loss_dict["loss"]
+ + self.training_args.diffusion_loss_weight * diffusion_loss_dict["loss"]
+ + self.training_args.distogram_loss_weight * disto_loss
+ + self.training_args.get("bfactor_loss_weight", 0.0) * bfactor_loss
+ )
+
+ if not (self.global_step % self.log_loss_every_steps):
+ # Log losses
+ if self.validate_structure:
+ self.log("train/distogram_loss", disto_loss)
+ self.log("train/diffusion_loss", diffusion_loss_dict["loss"])
+ for k, v in diffusion_loss_dict["loss_breakdown"].items():
+ self.log(f"train/{k}", v)
+
+ if self.confidence_prediction:
+ self.train_confidence_loss_logger.update(
+ confidence_loss_dict["loss"].detach()
+ )
+ for k in self.train_confidence_loss_dict_logger:
+ self.train_confidence_loss_dict_logger[k].update(
+ (
+ confidence_loss_dict["loss_breakdown"][k].detach()
+ if torch.is_tensor(
+ confidence_loss_dict["loss_breakdown"][k]
+ )
+ else confidence_loss_dict["loss_breakdown"][k]
+ )
+ )
+ self.log("train/loss", loss)
+ self.training_log()
+ return loss
+
+ def training_log(self):
+ self.log("train/grad_norm", self.gradient_norm(self), prog_bar=False)
+ self.log("train/param_norm", self.parameter_norm(self), prog_bar=False)
+
+ lr = self.trainer.optimizers[0].param_groups[0]["lr"]
+ self.log("lr", lr, prog_bar=False)
+
+ self.log(
+ "train/param_norm_msa_module",
+ self.parameter_norm(self.msa_module),
+ prog_bar=False,
+ )
+
+ self.log(
+ "train/param_norm_pairformer_module",
+ self.parameter_norm(self.pairformer_module),
+ prog_bar=False,
+ )
+
+ self.log(
+ "train/param_norm_structure_module",
+ self.parameter_norm(self.structure_module),
+ prog_bar=False,
+ )
+
+ if self.confidence_prediction:
+ self.log(
+ "train/grad_norm_confidence_module",
+ self.gradient_norm(self.confidence_module),
+ prog_bar=False,
+ )
+ self.log(
+ "train/param_norm_confidence_module",
+ self.parameter_norm(self.confidence_module),
+ prog_bar=False,
+ )
+
+ def on_train_epoch_end(self):
+ if self.confidence_prediction:
+ self.log(
+ "train/confidence_loss",
+ self.train_confidence_loss_logger,
+ prog_bar=False,
+ on_step=False,
+ on_epoch=True,
+ )
+ for k, v in self.train_confidence_loss_dict_logger.items():
+ self.log(f"train/{k}", v, prog_bar=False, on_step=False, on_epoch=True)
+
+ def gradient_norm(self, module):
+ parameters = [
+ p.grad.norm(p=2) ** 2
+ for p in module.parameters()
+ if p.requires_grad and p.grad is not None
+ ]
+ if len(parameters) == 0:
+ return torch.tensor(
+ 0.0, device="cuda" if torch.cuda.is_available() else "cpu"
+ )
+ norm = torch.stack(parameters).sum().sqrt()
+ return norm
+
+ def parameter_norm(self, module):
+ parameters = [p.norm(p=2) ** 2 for p in module.parameters() if p.requires_grad]
+ if len(parameters) == 0:
+ return torch.tensor(
+ 0.0, device="cuda" if torch.cuda.is_available() else "cpu"
+ )
+ norm = torch.stack(parameters).sum().sqrt()
+ return norm
+
+ def validation_step(self, batch: dict[str, Tensor], batch_idx: int):
+ if self.validate_structure:
+ try:
+ msg = "Only batch=1 is supported for validation"
+ assert batch["idx_dataset"].shape[0] == 1, msg
+
+ # Select validator based on dataset
+ idx_dataset = batch["idx_dataset"][0].item()
+ validator = self.validator_mapper[idx_dataset]
+
+ # Run forward pass
+ out = validator.run_model(
+ model=self, batch=batch, idx_dataset=idx_dataset
+ )
+ # Compute validation step
+ validator.process(
+ model=self, batch=batch, out=out, idx_dataset=idx_dataset
+ )
+ except RuntimeError as e: # catch out of memory exceptions
+ idx_dataset = batch["idx_dataset"][0].item()
+ if "out of memory" in str(e):
+ msg = f"| WARNING: ran out of memory, skipping batch, {idx_dataset}"
+ print(msg)
+ torch.cuda.empty_cache()
+ gc.collect()
+ return
+ raise e
+ else:
+ try:
+ out = self(
+ batch,
+ recycling_steps=self.validation_args.recycling_steps,
+ num_sampling_steps=self.validation_args.sampling_steps,
+ diffusion_samples=self.validation_args.diffusion_samples,
+ run_confidence_sequentially=self.validation_args.get(
+ "run_confidence_sequentially", False
+ ),
+ )
+ except RuntimeError as e: # catch out of memory exceptions
+ idx_dataset = batch["idx_dataset"][0].item()
+ if "out of memory" in str(e):
+ msg = f"| WARNING: ran out of memory, skipping batch, {idx_dataset}"
+ print(msg)
+ torch.cuda.empty_cache()
+ gc.collect()
+ return
+ raise e
+
+ def on_validation_epoch_end(self):
+ """Aggregate all metrics for each validator."""
+ if self.validate_structure:
+ for validator in self.validator_mapper.values():
+ # This will aggregate, compute and log all metrics
+ validator.on_epoch_end(model=self)
+
+ def predict_step(self, batch: Any, batch_idx: int, dataloader_idx: int = 0) -> dict:
+ try:
+ out = self(
+ batch,
+ recycling_steps=self.predict_args["recycling_steps"],
+ num_sampling_steps=self.predict_args["sampling_steps"],
+ diffusion_samples=self.predict_args["diffusion_samples"],
+ max_parallel_samples=self.predict_args["max_parallel_samples"],
+ run_confidence_sequentially=True,
+ )
+ pred_dict = {"exception": False}
+ if "keys_dict_batch" in self.predict_args:
+ for key in self.predict_args["keys_dict_batch"]:
+ pred_dict[key] = batch[key]
+
+ pred_dict["masks"] = batch["atom_pad_mask"]
+ pred_dict["token_masks"] = batch["token_pad_mask"]
+ pred_dict["s"] = out["s"]
+ pred_dict["z"] = out["z"]
+
+ if "keys_dict_out" in self.predict_args:
+ for key in self.predict_args["keys_dict_out"]:
+ pred_dict[key] = out[key]
+ pred_dict["coords"] = out["sample_atom_coords"]
+ if self.confidence_prediction:
+ # pred_dict["confidence"] = out.get("ablation_confidence", None)
+ pred_dict["pde"] = out["pde"]
+ pred_dict["plddt"] = out["plddt"]
+ pred_dict["confidence_score"] = (
+ 4 * out["complex_plddt"]
+ + (
+ out["iptm"]
+ if not torch.allclose(
+ out["iptm"], torch.zeros_like(out["iptm"])
+ )
+ else out["ptm"]
+ )
+ ) / 5
+
+ pred_dict["complex_plddt"] = out["complex_plddt"]
+ pred_dict["complex_iplddt"] = out["complex_iplddt"]
+ pred_dict["complex_pde"] = out["complex_pde"]
+ pred_dict["complex_ipde"] = out["complex_ipde"]
+ if self.alpha_pae > 0:
+ pred_dict["pae"] = out["pae"]
+ pred_dict["ptm"] = out["ptm"]
+ pred_dict["iptm"] = out["iptm"]
+ pred_dict["ligand_iptm"] = out["ligand_iptm"]
+ pred_dict["protein_iptm"] = out["protein_iptm"]
+ pred_dict["pair_chains_iptm"] = out["pair_chains_iptm"]
+ if self.affinity_prediction:
+ pred_dict["affinity_pred_value"] = out["affinity_pred_value"]
+ pred_dict["affinity_probability_binary"] = out[
+ "affinity_probability_binary"
+ ]
+ if self.affinity_ensemble:
+ pred_dict["affinity_pred_value1"] = out["affinity_pred_value1"]
+ pred_dict["affinity_probability_binary1"] = out[
+ "affinity_probability_binary1"
+ ]
+ pred_dict["affinity_pred_value2"] = out["affinity_pred_value2"]
+ pred_dict["affinity_probability_binary2"] = out[
+ "affinity_probability_binary2"
+ ]
+ return pred_dict
+
+ except RuntimeError as e: # catch out of memory exceptions
+ if "out of memory" in str(e):
+ print("| WARNING: ran out of memory, skipping batch")
+ torch.cuda.empty_cache()
+ gc.collect()
+ return {"exception": True}
+ else:
+ raise e
+
+ def configure_optimizers(self) -> torch.optim.Optimizer:
+ """Configure the optimizer."""
+ param_dict = dict(self.named_parameters())
+
+ if self.structure_prediction_training:
+ all_parameter_names = [
+ pn for pn, p in self.named_parameters() if p.requires_grad
+ ]
+ else:
+ all_parameter_names = [
+ pn
+ for pn, p in self.named_parameters()
+ if p.requires_grad
+ and ("out_token_feat_update" in pn or "confidence_module" in pn)
+ ]
+
+ if self.training_args.get("weight_decay", 0.0) > 0:
+ w_decay = self.training_args.get("weight_decay", 0.0)
+ if self.training_args.get("weight_decay_exclude", False):
+ nodecay_params_names = [
+ pn
+ for pn in all_parameter_names
+ if (
+ "norm" in pn
+ or "rel_pos" in pn
+ or ".s_init" in pn
+ or ".z_init_" in pn
+ or "token_bonds" in pn
+ or "embed_atom_features" in pn
+ or "dist_bin_pairwise_embed" in pn
+ )
+ ]
+ nodecay_params = [param_dict[pn] for pn in nodecay_params_names]
+ decay_params = [
+ param_dict[pn]
+ for pn in all_parameter_names
+ if pn not in nodecay_params_names
+ ]
+ optim_groups = [
+ {"params": decay_params, "weight_decay": w_decay},
+ {"params": nodecay_params, "weight_decay": 0.0},
+ ]
+ optimizer = torch.optim.AdamW(
+ optim_groups,
+ betas=(
+ self.training_args.adam_beta_1,
+ self.training_args.adam_beta_2,
+ ),
+ eps=self.training_args.adam_eps,
+ lr=self.training_args.base_lr,
+ )
+
+ else:
+ optimizer = torch.optim.AdamW(
+ [param_dict[pn] for pn in all_parameter_names],
+ betas=(
+ self.training_args.adam_beta_1,
+ self.training_args.adam_beta_2,
+ ),
+ eps=self.training_args.adam_eps,
+ lr=self.training_args.base_lr,
+ weight_decay=self.training_args.get("weight_decay", 0.0),
+ )
+ else:
+ optimizer = torch.optim.AdamW(
+ [param_dict[pn] for pn in all_parameter_names],
+ betas=(self.training_args.adam_beta_1, self.training_args.adam_beta_2),
+ eps=self.training_args.adam_eps,
+ lr=self.training_args.base_lr,
+ weight_decay=self.training_args.get("weight_decay", 0.0),
+ )
+
+ if self.training_args.lr_scheduler == "af3":
+ scheduler = AlphaFoldLRScheduler(
+ optimizer,
+ base_lr=self.training_args.base_lr,
+ max_lr=self.training_args.max_lr,
+ warmup_no_steps=self.training_args.lr_warmup_no_steps,
+ start_decay_after_n_steps=self.training_args.lr_start_decay_after_n_steps,
+ decay_every_n_steps=self.training_args.lr_decay_every_n_steps,
+ decay_factor=self.training_args.lr_decay_factor,
+ )
+ return [optimizer], [{"scheduler": scheduler, "interval": "step"}]
+
+ return optimizer
+
+ def on_load_checkpoint(self, checkpoint: dict[str, Any]) -> None:
+ # Ignore the lr from the checkpoint
+ lr = self.training_args.max_lr
+ weight_decay = self.training_args.weight_decay
+ if "optimizer_states" in checkpoint:
+ for state in checkpoint["optimizer_states"]:
+ for group in state["param_groups"]:
+ group["lr"] = lr
+ group["weight_decay"] = weight_decay
+ if "lr_schedulers" in checkpoint:
+ for scheduler in checkpoint["lr_schedulers"]:
+ scheduler["max_lr"] = lr
+ scheduler["base_lrs"] = [lr] * len(scheduler["base_lrs"])
+ scheduler["_last_lr"] = [lr] * len(scheduler["_last_lr"])
+
+ # Ignore the training diffusion_multiplicity and recycling steps from the checkpoint
+ if "hyper_parameters" in checkpoint:
+ checkpoint["hyper_parameters"]["training_args"]["max_lr"] = lr
+ checkpoint["hyper_parameters"]["training_args"][
+ "diffusion_multiplicity"
+ ] = self.training_args.diffusion_multiplicity
+ checkpoint["hyper_parameters"]["training_args"]["recycling_steps"] = (
+ self.training_args.recycling_steps
+ )
+ checkpoint["hyper_parameters"]["training_args"]["weight_decay"] = (
+ self.training_args.weight_decay
+ )
+
+ def configure_callbacks(self) -> list[Callback]:
+ """Configure model callbacks.
+
+ Returns
+ -------
+ List[Callback]
+ List of callbacks to be used in the model.
+
+ """
+ return [EMA(self.ema_decay)] if self.use_ema else []
diff --git a/forks/boltz/src/boltz/model/modules/__init__.py b/forks/boltz/src/boltz/model/modules/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/model/modules/affinity.py b/forks/boltz/src/boltz/model/modules/affinity.py
new file mode 100644
index 00000000..da14e3e6
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/affinity.py
@@ -0,0 +1,223 @@
+import torch
+from torch import nn
+
+import boltz.model.layers.initialize as init
+from boltz.model.layers.pairformer import PairformerNoSeqModule
+from boltz.model.modules.encodersv2 import PairwiseConditioning
+from boltz.model.modules.transformersv2 import DiffusionTransformer
+from boltz.model.modules.utils import LinearNoBias
+
+
+class GaussianSmearing(torch.nn.Module):
+ """Gaussian smearing."""
+
+ def __init__(
+ self,
+ start: float = 0.0,
+ stop: float = 5.0,
+ num_gaussians: int = 50,
+ ) -> None:
+ super().__init__()
+ offset = torch.linspace(start, stop, num_gaussians)
+ self.num_gaussians = num_gaussians
+ self.coeff = -0.5 / (offset[1] - offset[0]).item() ** 2
+ self.register_buffer("offset", offset)
+
+ def forward(self, dist):
+ shape = dist.shape
+ dist = dist.view(-1, 1) - self.offset.view(1, -1)
+ return torch.exp(self.coeff * torch.pow(dist, 2)).reshape(
+ *shape, self.num_gaussians
+ )
+
+
+class AffinityModule(nn.Module):
+ """Algorithm 31"""
+
+ def __init__(
+ self,
+ token_s,
+ token_z,
+ pairformer_args: dict,
+ transformer_args: dict,
+ num_dist_bins=64,
+ max_dist=22,
+ use_cross_transformer: bool = False,
+ groups: dict = {},
+ ):
+ super().__init__()
+ boundaries = torch.linspace(2, max_dist, num_dist_bins - 1)
+ self.register_buffer("boundaries", boundaries)
+ self.dist_bin_pairwise_embed = nn.Embedding(num_dist_bins, token_z)
+ init.gating_init_(self.dist_bin_pairwise_embed.weight)
+
+ self.s_to_z_prod_in1 = LinearNoBias(token_s, token_z)
+ self.s_to_z_prod_in2 = LinearNoBias(token_s, token_z)
+
+ self.z_norm = nn.LayerNorm(token_z)
+ self.z_linear = LinearNoBias(token_z, token_z)
+
+ self.pairwise_conditioner = PairwiseConditioning(
+ token_z=token_z,
+ dim_token_rel_pos_feats=token_z,
+ num_transitions=2,
+ )
+
+ self.pairformer_stack = PairformerNoSeqModule(token_z, **pairformer_args)
+ self.affinity_heads = AffinityHeadsTransformer(
+ token_z,
+ transformer_args["token_s"],
+ transformer_args["num_blocks"],
+ transformer_args["num_heads"],
+ transformer_args["activation_checkpointing"],
+ False,
+ groups=groups,
+ )
+
+ def forward(
+ self,
+ s_inputs,
+ z,
+ x_pred,
+ feats,
+ multiplicity=1,
+ use_kernels=False,
+ ):
+ z = self.z_linear(self.z_norm(z))
+ z = z.repeat_interleave(multiplicity, 0)
+
+ z = (
+ z
+ + self.s_to_z_prod_in1(s_inputs)[:, :, None, :]
+ + self.s_to_z_prod_in2(s_inputs)[:, None, :, :]
+ )
+
+ token_to_rep_atom = feats["token_to_rep_atom"]
+ token_to_rep_atom = token_to_rep_atom.repeat_interleave(multiplicity, 0)
+ if len(x_pred.shape) == 4:
+ B, mult, N, _ = x_pred.shape
+ x_pred = x_pred.reshape(B * mult, N, -1)
+ else:
+ BM, N, _ = x_pred.shape
+ B = BM // multiplicity
+ mult = multiplicity
+ x_pred_repr = torch.bmm(token_to_rep_atom.float(), x_pred)
+ d = torch.cdist(x_pred_repr, x_pred_repr)
+
+ distogram = (d.unsqueeze(-1) > self.boundaries).sum(dim=-1).long()
+ distogram = self.dist_bin_pairwise_embed(distogram)
+
+ z = z + self.pairwise_conditioner(z_trunk=z, token_rel_pos_feats=distogram)
+
+ pad_token_mask = feats["token_pad_mask"].repeat_interleave(multiplicity, 0)
+ rec_mask = (feats["mol_type"] == 0).repeat_interleave(multiplicity, 0)
+ rec_mask = rec_mask * pad_token_mask
+ lig_mask = (
+ feats["affinity_token_mask"]
+ .repeat_interleave(multiplicity, 0)
+ .to(torch.bool)
+ )
+ lig_mask = lig_mask * pad_token_mask
+ cross_pair_mask = (
+ lig_mask[:, :, None] * rec_mask[:, None, :]
+ + rec_mask[:, :, None] * lig_mask[:, None, :]
+ + lig_mask[:, :, None] * lig_mask[:, None, :]
+ )
+ z = self.pairformer_stack(
+ z,
+ pair_mask=cross_pair_mask,
+ use_kernels=use_kernels,
+ )
+
+ out_dict = {}
+
+ # affinity heads
+ out_dict.update(
+ self.affinity_heads(z=z, feats=feats, multiplicity=multiplicity)
+ )
+
+ return out_dict
+
+
+class AffinityHeadsTransformer(nn.Module):
+ def __init__(
+ self,
+ token_z,
+ input_token_s,
+ num_blocks,
+ num_heads,
+ activation_checkpointing,
+ use_cross_transformer,
+ groups={},
+ ):
+ super().__init__()
+ self.affinity_out_mlp = nn.Sequential(
+ nn.Linear(token_z, token_z),
+ nn.ReLU(),
+ nn.Linear(token_z, input_token_s),
+ nn.ReLU(),
+ )
+
+ self.to_affinity_pred_value = nn.Sequential(
+ nn.Linear(input_token_s, input_token_s),
+ nn.ReLU(),
+ nn.Linear(input_token_s, input_token_s),
+ nn.ReLU(),
+ nn.Linear(input_token_s, 1),
+ )
+
+ self.to_affinity_pred_score = nn.Sequential(
+ nn.Linear(input_token_s, input_token_s),
+ nn.ReLU(),
+ nn.Linear(input_token_s, input_token_s),
+ nn.ReLU(),
+ nn.Linear(input_token_s, 1),
+ )
+ self.to_affinity_logits_binary = nn.Linear(1, 1)
+
+ def forward(
+ self,
+ z,
+ feats,
+ multiplicity=1,
+ ):
+ pad_token_mask = (
+ feats["token_pad_mask"].repeat_interleave(multiplicity, 0).unsqueeze(-1)
+ )
+ rec_mask = (
+ (feats["mol_type"] == 0).repeat_interleave(multiplicity, 0).unsqueeze(-1)
+ )
+ rec_mask = rec_mask * pad_token_mask
+ lig_mask = (
+ feats["affinity_token_mask"]
+ .repeat_interleave(multiplicity, 0)
+ .to(torch.bool)
+ .unsqueeze(-1)
+ ) * pad_token_mask
+ cross_pair_mask = (
+ lig_mask[:, :, None] * rec_mask[:, None, :]
+ + rec_mask[:, :, None] * lig_mask[:, None, :]
+ + (lig_mask[:, :, None] * lig_mask[:, None, :])
+ ) * (
+ 1
+ - torch.eye(lig_mask.shape[1], device=lig_mask.device)
+ .unsqueeze(-1)
+ .unsqueeze(0)
+ )
+
+ g = torch.sum(z * cross_pair_mask, dim=(1, 2)) / (
+ torch.sum(cross_pair_mask, dim=(1, 2)) + 1e-7
+ )
+
+ g = self.affinity_out_mlp(g)
+
+ affinity_pred_value = self.to_affinity_pred_value(g).reshape(-1, 1)
+ affinity_pred_score = self.to_affinity_pred_score(g).reshape(-1, 1)
+ affinity_logits_binary = self.to_affinity_logits_binary(
+ affinity_pred_score
+ ).reshape(-1, 1)
+ out_dict = {
+ "affinity_pred_value": affinity_pred_value,
+ "affinity_logits_binary": affinity_logits_binary,
+ }
+ return out_dict
diff --git a/forks/boltz/src/boltz/model/modules/confidence.py b/forks/boltz/src/boltz/model/modules/confidence.py
new file mode 100755
index 00000000..4fb0fa6e
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/confidence.py
@@ -0,0 +1,481 @@
+import torch
+import torch.nn.functional as F
+from torch import nn
+
+import boltz.model.layers.initialize as init
+from boltz.data import const
+from boltz.model.modules.confidence_utils import (
+ compute_aggregated_metric,
+ compute_ptms,
+)
+from boltz.model.modules.encoders import RelativePositionEncoder
+from boltz.model.modules.trunk import (
+ InputEmbedder,
+ MSAModule,
+ PairformerModule,
+)
+from boltz.model.modules.utils import LinearNoBias
+
+
+class ConfidenceModule(nn.Module):
+ """Confidence module."""
+
+ def __init__(
+ self,
+ token_s,
+ token_z,
+ pairformer_args: dict,
+ num_dist_bins=64,
+ max_dist=22,
+ add_s_to_z_prod=False,
+ add_s_input_to_s=False,
+ use_s_diffusion=False,
+ add_z_input_to_z=False,
+ confidence_args: dict = None,
+ compute_pae: bool = False,
+ imitate_trunk=False,
+ full_embedder_args: dict = None,
+ msa_args: dict = None,
+ compile_pairformer=False,
+ ):
+ """Initialize the confidence module.
+
+ Parameters
+ ----------
+ token_s : int
+ The single representation dimension.
+ token_z : int
+ The pair representation dimension.
+ pairformer_args : int
+ The pairformer arguments.
+ num_dist_bins : int, optional
+ The number of distance bins, by default 64.
+ max_dist : int, optional
+ The maximum distance, by default 22.
+ add_s_to_z_prod : bool, optional
+ Whether to add s to z product, by default False.
+ add_s_input_to_s : bool, optional
+ Whether to add s input to s, by default False.
+ use_s_diffusion : bool, optional
+ Whether to use s diffusion, by default False.
+ add_z_input_to_z : bool, optional
+ Whether to add z input to z, by default False.
+ confidence_args : dict, optional
+ The confidence arguments, by default None.
+ compute_pae : bool, optional
+ Whether to compute pae, by default False.
+ imitate_trunk : bool, optional
+ Whether to imitate trunk, by default False.
+ full_embedder_args : dict, optional
+ The full embedder arguments, by default None.
+ msa_args : dict, optional
+ The msa arguments, by default None.
+ compile_pairformer : bool, optional
+ Whether to compile pairformer, by default False.
+
+ """
+ super().__init__()
+ self.max_num_atoms_per_token = 23
+ self.no_update_s = pairformer_args.get("no_update_s", False)
+ boundaries = torch.linspace(2, max_dist, num_dist_bins - 1)
+ self.register_buffer("boundaries", boundaries)
+ self.dist_bin_pairwise_embed = nn.Embedding(num_dist_bins, token_z)
+ init.gating_init_(self.dist_bin_pairwise_embed.weight)
+ s_input_dim = (
+ token_s + 2 * const.num_tokens + 1 + len(const.pocket_contact_info)
+ )
+
+ self.use_s_diffusion = use_s_diffusion
+ if use_s_diffusion:
+ self.s_diffusion_norm = nn.LayerNorm(2 * token_s)
+ self.s_diffusion_to_s = LinearNoBias(2 * token_s, token_s)
+ init.gating_init_(self.s_diffusion_to_s.weight)
+
+ self.s_to_z = LinearNoBias(s_input_dim, token_z)
+ self.s_to_z_transpose = LinearNoBias(s_input_dim, token_z)
+ init.gating_init_(self.s_to_z.weight)
+ init.gating_init_(self.s_to_z_transpose.weight)
+
+ self.add_s_to_z_prod = add_s_to_z_prod
+ if add_s_to_z_prod:
+ self.s_to_z_prod_in1 = LinearNoBias(s_input_dim, token_z)
+ self.s_to_z_prod_in2 = LinearNoBias(s_input_dim, token_z)
+ self.s_to_z_prod_out = LinearNoBias(token_z, token_z)
+ init.gating_init_(self.s_to_z_prod_out.weight)
+
+ self.imitate_trunk = imitate_trunk
+ if self.imitate_trunk:
+ s_input_dim = (
+ token_s + 2 * const.num_tokens + 1 + len(const.pocket_contact_info)
+ )
+ self.s_init = nn.Linear(s_input_dim, token_s, bias=False)
+ self.z_init_1 = nn.Linear(s_input_dim, token_z, bias=False)
+ self.z_init_2 = nn.Linear(s_input_dim, token_z, bias=False)
+
+ # Input embeddings
+ self.input_embedder = InputEmbedder(**full_embedder_args)
+ self.rel_pos = RelativePositionEncoder(token_z)
+ self.token_bonds = nn.Linear(1, token_z, bias=False)
+
+ # Normalization layers
+ self.s_norm = nn.LayerNorm(token_s)
+ self.z_norm = nn.LayerNorm(token_z)
+
+ # Recycling projections
+ self.s_recycle = nn.Linear(token_s, token_s, bias=False)
+ self.z_recycle = nn.Linear(token_z, token_z, bias=False)
+ init.gating_init_(self.s_recycle.weight)
+ init.gating_init_(self.z_recycle.weight)
+
+ # Pairwise stack
+ self.msa_module = MSAModule(
+ token_z=token_z,
+ s_input_dim=s_input_dim,
+ **msa_args,
+ )
+ self.pairformer_module = PairformerModule(
+ token_s,
+ token_z,
+ **pairformer_args,
+ )
+ if compile_pairformer:
+ # Big models hit the default cache limit (8)
+ self.is_pairformer_compiled = True
+ torch._dynamo.config.cache_size_limit = 512
+ torch._dynamo.config.accumulated_cache_size_limit = 512
+ self.pairformer_module = torch.compile(
+ self.pairformer_module,
+ dynamic=False,
+ fullgraph=False,
+ )
+
+ self.final_s_norm = nn.LayerNorm(token_s)
+ self.final_z_norm = nn.LayerNorm(token_z)
+ else:
+ self.s_inputs_norm = nn.LayerNorm(s_input_dim)
+ if not self.no_update_s:
+ self.s_norm = nn.LayerNorm(token_s)
+ self.z_norm = nn.LayerNorm(token_z)
+
+ self.add_s_input_to_s = add_s_input_to_s
+ if add_s_input_to_s:
+ self.s_input_to_s = LinearNoBias(s_input_dim, token_s)
+ init.gating_init_(self.s_input_to_s.weight)
+
+ self.add_z_input_to_z = add_z_input_to_z
+ if add_z_input_to_z:
+ self.rel_pos = RelativePositionEncoder(token_z)
+ self.token_bonds = nn.Linear(1, token_z, bias=False)
+
+ self.pairformer_stack = PairformerModule(
+ token_s,
+ token_z,
+ **pairformer_args,
+ )
+
+ self.confidence_heads = ConfidenceHeads(
+ token_s,
+ token_z,
+ compute_pae=compute_pae,
+ **confidence_args,
+ )
+
+ def forward(
+ self,
+ s_inputs,
+ s,
+ z,
+ x_pred,
+ feats,
+ pred_distogram_logits,
+ multiplicity=1,
+ s_diffusion=None,
+ run_sequentially=False,
+ use_kernels: bool = False,
+ ):
+ if run_sequentially and multiplicity > 1:
+ assert z.shape[0] == 1, "Not supported with batch size > 1"
+ out_dicts = []
+ for sample_idx in range(multiplicity):
+ out_dicts.append( # noqa: PERF401
+ self.forward(
+ s_inputs,
+ s,
+ z,
+ x_pred[sample_idx : sample_idx + 1],
+ feats,
+ pred_distogram_logits,
+ multiplicity=1,
+ s_diffusion=s_diffusion[sample_idx : sample_idx + 1]
+ if s_diffusion is not None
+ else None,
+ run_sequentially=False,
+ use_kernels=use_kernels,
+ )
+ )
+
+ out_dict = {}
+ for key in out_dicts[0]:
+ if key != "pair_chains_iptm":
+ out_dict[key] = torch.cat([out[key] for out in out_dicts], dim=0)
+ else:
+ pair_chains_iptm = {}
+ for chain_idx1 in out_dicts[0][key].keys():
+ chains_iptm = {}
+ for chain_idx2 in out_dicts[0][key][chain_idx1].keys():
+ chains_iptm[chain_idx2] = torch.cat(
+ [out[key][chain_idx1][chain_idx2] for out in out_dicts],
+ dim=0,
+ )
+ pair_chains_iptm[chain_idx1] = chains_iptm
+ out_dict[key] = pair_chains_iptm
+ return out_dict
+ if self.imitate_trunk:
+ s_inputs = self.input_embedder(feats)
+
+ # Initialize the sequence and pairwise embeddings
+ s_init = self.s_init(s_inputs)
+ z_init = (
+ self.z_init_1(s_inputs)[:, :, None]
+ + self.z_init_2(s_inputs)[:, None, :]
+ )
+ relative_position_encoding = self.rel_pos(feats)
+ z_init = z_init + relative_position_encoding
+ z_init = z_init + self.token_bonds(feats["token_bonds"].float())
+
+ # Apply recycling
+ s = s_init + self.s_recycle(self.s_norm(s))
+ z = z_init + self.z_recycle(self.z_norm(z))
+
+ else:
+ s_inputs = self.s_inputs_norm(s_inputs).repeat_interleave(multiplicity, 0)
+ if not self.no_update_s:
+ s = self.s_norm(s)
+
+ if self.add_s_input_to_s:
+ s = s + self.s_input_to_s(s_inputs)
+
+ z = self.z_norm(z)
+
+ if self.add_z_input_to_z:
+ relative_position_encoding = self.rel_pos(feats)
+ z = z + relative_position_encoding
+ z = z + self.token_bonds(feats["token_bonds"].float())
+
+ s = s.repeat_interleave(multiplicity, 0)
+
+ if self.use_s_diffusion:
+ assert s_diffusion is not None
+ s_diffusion = self.s_diffusion_norm(s_diffusion)
+ s = s + self.s_diffusion_to_s(s_diffusion)
+
+ z = z.repeat_interleave(multiplicity, 0)
+ z = (
+ z
+ + self.s_to_z(s_inputs)[:, :, None, :]
+ + self.s_to_z_transpose(s_inputs)[:, None, :, :]
+ )
+
+ if self.add_s_to_z_prod:
+ z = z + self.s_to_z_prod_out(
+ self.s_to_z_prod_in1(s_inputs)[:, :, None, :]
+ * self.s_to_z_prod_in2(s_inputs)[:, None, :, :]
+ )
+
+ token_to_rep_atom = feats["token_to_rep_atom"]
+ token_to_rep_atom = token_to_rep_atom.repeat_interleave(multiplicity, 0)
+ if len(x_pred.shape) == 4:
+ B, mult, N, _ = x_pred.shape
+ x_pred = x_pred.reshape(B * mult, N, -1)
+ x_pred_repr = torch.bmm(token_to_rep_atom.float(), x_pred)
+ d = torch.cdist(x_pred_repr, x_pred_repr)
+
+ distogram = (d.unsqueeze(-1) > self.boundaries).sum(dim=-1).long()
+ distogram = self.dist_bin_pairwise_embed(distogram)
+
+ z = z + distogram
+
+ mask = feats["token_pad_mask"].repeat_interleave(multiplicity, 0)
+ pair_mask = mask[:, :, None] * mask[:, None, :]
+
+ if self.imitate_trunk:
+ z = z + self.msa_module(z, s_inputs, feats, use_kernels=use_kernels)
+
+ s, z = self.pairformer_module(
+ s, z, mask=mask, pair_mask=pair_mask, use_kernels=use_kernels
+ )
+
+ s, z = self.final_s_norm(s), self.final_z_norm(z)
+
+ else:
+ s_t, z_t = self.pairformer_stack(
+ s, z, mask=mask, pair_mask=pair_mask, use_kernels=use_kernels
+ )
+
+ # AF3 has residual connections, we remove them
+ s = s_t
+ z = z_t
+
+ out_dict = {}
+
+ # confidence heads
+ out_dict.update(
+ self.confidence_heads(
+ s=s,
+ z=z,
+ x_pred=x_pred,
+ d=d,
+ feats=feats,
+ multiplicity=multiplicity,
+ pred_distogram_logits=pred_distogram_logits,
+ )
+ )
+
+ return out_dict
+
+
+class ConfidenceHeads(nn.Module):
+ """Confidence heads."""
+
+ def __init__(
+ self,
+ token_s,
+ token_z,
+ num_plddt_bins=50,
+ num_pde_bins=64,
+ num_pae_bins=64,
+ compute_pae: bool = True,
+ ):
+ """Initialize the confidence head.
+
+ Parameters
+ ----------
+ token_s : int
+ The single representation dimension.
+ token_z : int
+ The pair representation dimension.
+ num_plddt_bins : int
+ The number of plddt bins, by default 50.
+ num_pde_bins : int
+ The number of pde bins, by default 64.
+ num_pae_bins : int
+ The number of pae bins, by default 64.
+ compute_pae : bool
+ Whether to compute pae, by default False
+
+ """
+ super().__init__()
+ self.max_num_atoms_per_token = 23
+ self.to_pde_logits = LinearNoBias(token_z, num_pde_bins)
+ self.to_plddt_logits = LinearNoBias(token_s, num_plddt_bins)
+ self.to_resolved_logits = LinearNoBias(token_s, 2)
+ self.compute_pae = compute_pae
+ if self.compute_pae:
+ self.to_pae_logits = LinearNoBias(token_z, num_pae_bins)
+
+ def forward(
+ self,
+ s,
+ z,
+ x_pred,
+ d,
+ feats,
+ pred_distogram_logits,
+ multiplicity=1,
+ ):
+ # Compute the pLDDT, PDE, PAE, and resolved logits
+ plddt_logits = self.to_plddt_logits(s)
+ pde_logits = self.to_pde_logits(z + z.transpose(1, 2))
+ resolved_logits = self.to_resolved_logits(s)
+ if self.compute_pae:
+ pae_logits = self.to_pae_logits(z)
+
+ # Weights used to compute the interface pLDDT
+ ligand_weight = 2
+ interface_weight = 1
+
+ # Retrieve relevant features
+ token_type = feats["mol_type"]
+ token_type = token_type.repeat_interleave(multiplicity, 0)
+ is_ligand_token = (token_type == const.chain_type_ids["NONPOLYMER"]).float()
+
+ # Compute the aggregated pLDDT and iPLDDT
+ plddt = compute_aggregated_metric(plddt_logits)
+ token_pad_mask = feats["token_pad_mask"].repeat_interleave(multiplicity, 0)
+ complex_plddt = (plddt * token_pad_mask).sum(dim=-1) / token_pad_mask.sum(
+ dim=-1
+ )
+
+ is_contact = (d < 8).float()
+ is_different_chain = (
+ feats["asym_id"].unsqueeze(-1) != feats["asym_id"].unsqueeze(-2)
+ ).float()
+ is_different_chain = is_different_chain.repeat_interleave(multiplicity, 0)
+ token_interface_mask = torch.max(
+ is_contact * is_different_chain * (1 - is_ligand_token).unsqueeze(-1),
+ dim=-1,
+ ).values
+ iplddt_weight = (
+ is_ligand_token * ligand_weight + token_interface_mask * interface_weight
+ )
+ complex_iplddt = (plddt * token_pad_mask * iplddt_weight).sum(dim=-1) / (
+ torch.sum(token_pad_mask * iplddt_weight, dim=-1) + 1e-5
+ )
+
+ # Compute the aggregated PDE and iPDE
+ pde = compute_aggregated_metric(pde_logits, end=32)
+ pred_distogram_prob = nn.functional.softmax(
+ pred_distogram_logits, dim=-1
+ ).repeat_interleave(multiplicity, 0)
+ contacts = torch.zeros((1, 1, 1, 64), dtype=pred_distogram_prob.dtype).to(
+ pred_distogram_prob.device
+ )
+ contacts[:, :, :, :20] = 1.0
+ prob_contact = (pred_distogram_prob * contacts).sum(-1)
+ token_pad_mask = feats["token_pad_mask"].repeat_interleave(multiplicity, 0)
+ token_pad_pair_mask = (
+ token_pad_mask.unsqueeze(-1)
+ * token_pad_mask.unsqueeze(-2)
+ * (
+ 1
+ - torch.eye(
+ token_pad_mask.shape[1], device=token_pad_mask.device
+ ).unsqueeze(0)
+ )
+ )
+ token_pair_mask = token_pad_pair_mask * prob_contact
+ complex_pde = (pde * token_pair_mask).sum(dim=(1, 2)) / token_pair_mask.sum(
+ dim=(1, 2)
+ )
+ asym_id = feats["asym_id"].repeat_interleave(multiplicity, 0)
+ token_interface_pair_mask = token_pair_mask * (
+ asym_id.unsqueeze(-1) != asym_id.unsqueeze(-2)
+ )
+ complex_ipde = (pde * token_interface_pair_mask).sum(dim=(1, 2)) / (
+ token_interface_pair_mask.sum(dim=(1, 2)) + 1e-5
+ )
+
+ out_dict = dict(
+ pde_logits=pde_logits,
+ plddt_logits=plddt_logits,
+ resolved_logits=resolved_logits,
+ pde=pde,
+ plddt=plddt,
+ complex_plddt=complex_plddt,
+ complex_iplddt=complex_iplddt,
+ complex_pde=complex_pde,
+ complex_ipde=complex_ipde,
+ )
+ if self.compute_pae:
+ out_dict["pae_logits"] = pae_logits
+ out_dict["pae"] = compute_aggregated_metric(pae_logits, end=32)
+ ptm, iptm, ligand_iptm, protein_iptm, pair_chains_iptm = compute_ptms(
+ pae_logits, x_pred, feats, multiplicity
+ )
+ out_dict["ptm"] = ptm
+ out_dict["iptm"] = iptm
+ out_dict["ligand_iptm"] = ligand_iptm
+ out_dict["protein_iptm"] = protein_iptm
+ out_dict["pair_chains_iptm"] = pair_chains_iptm
+
+ return out_dict
diff --git a/forks/boltz/src/boltz/model/modules/confidence_utils.py b/forks/boltz/src/boltz/model/modules/confidence_utils.py
new file mode 100644
index 00000000..5ffacf11
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/confidence_utils.py
@@ -0,0 +1,181 @@
+import torch
+from torch import nn
+
+from boltz.data import const
+from boltz.model.loss.confidence import compute_frame_pred
+
+
+def compute_aggregated_metric(logits, end=1.0):
+ """Compute the metric from the logits.
+
+ Parameters
+ ----------
+ logits : torch.Tensor
+ The logits of the metric
+ end : float
+ Max value of the metric, by default 1.0
+
+ Returns
+ -------
+ Tensor
+ The metric value
+
+ """
+ num_bins = logits.shape[-1]
+ bin_width = end / num_bins
+ bounds = torch.arange(
+ start=0.5 * bin_width, end=end, step=bin_width, device=logits.device
+ )
+ probs = nn.functional.softmax(logits, dim=-1)
+ plddt = torch.sum(
+ probs * bounds.view(*((1,) * len(probs.shape[:-1])), *bounds.shape),
+ dim=-1,
+ )
+ return plddt
+
+
+def tm_function(d, Nres):
+ """Compute the rescaling function for pTM.
+
+ Parameters
+ ----------
+ d : torch.Tensor
+ The input
+ Nres : torch.Tensor
+ The number of residues
+
+ Returns
+ -------
+ Tensor
+ Output of the function
+
+ """
+ d0 = 1.24 * (torch.clip(Nres, min=19) - 15) ** (1 / 3) - 1.8
+ return 1 / (1 + (d / d0) ** 2)
+
+
+def compute_ptms(logits, x_preds, feats, multiplicity):
+ """Compute pTM and ipTM scores.
+
+ Parameters
+ ----------
+ logits : torch.Tensor
+ pae logits
+ x_preds : torch.Tensor
+ The predicted coordinates
+ feats : Dict[str, torch.Tensor]
+ The input features
+ multiplicity : int
+ The batch size of the diffusion roll-out
+
+ Returns
+ -------
+ Tensor
+ pTM score
+ Tensor
+ ipTM score
+ Tensor
+ ligand ipTM score
+ Tensor
+ protein ipTM score
+
+ """
+ # Compute mask for collinear and overlapping tokens
+ _, mask_collinear_pred = compute_frame_pred(
+ x_preds, feats["frames_idx"], feats, multiplicity, inference=True
+ )
+ mask_pad = feats["token_pad_mask"].repeat_interleave(multiplicity, 0)
+ maski = mask_collinear_pred.reshape(-1, mask_collinear_pred.shape[-1])
+ pair_mask_ptm = maski[:, :, None] * mask_pad[:, None, :] * mask_pad[:, :, None]
+ asym_id = feats["asym_id"].repeat_interleave(multiplicity, 0)
+ pair_mask_iptm = (
+ maski[:, :, None]
+ * (asym_id[:, None, :] != asym_id[:, :, None])
+ * mask_pad[:, None, :]
+ * mask_pad[:, :, None]
+ )
+
+ # Extract pae values
+ num_bins = logits.shape[-1]
+ bin_width = 32.0 / num_bins
+ end = 32.0
+ pae_value = torch.arange(
+ start=0.5 * bin_width, end=end, step=bin_width, device=logits.device
+ ).unsqueeze(0)
+ N_res = mask_pad.sum(dim=-1, keepdim=True)
+
+ # compute pTM and ipTM
+ tm_value = tm_function(pae_value, N_res).unsqueeze(1).unsqueeze(2)
+ probs = nn.functional.softmax(logits, dim=-1)
+ tm_expected_value = torch.sum(
+ probs * tm_value,
+ dim=-1,
+ ) # shape (B, N, N)
+ ptm = torch.max(
+ torch.sum(tm_expected_value * pair_mask_ptm, dim=-1)
+ / (torch.sum(pair_mask_ptm, dim=-1) + 1e-5),
+ dim=1,
+ ).values
+ iptm = torch.max(
+ torch.sum(tm_expected_value * pair_mask_iptm, dim=-1)
+ / (torch.sum(pair_mask_iptm, dim=-1) + 1e-5),
+ dim=1,
+ ).values
+
+ # compute ligand and protein ipTM
+ token_type = feats["mol_type"]
+ token_type = token_type.repeat_interleave(multiplicity, 0)
+ is_ligand_token = (token_type == const.chain_type_ids["NONPOLYMER"]).float()
+ is_protein_token = (token_type == const.chain_type_ids["PROTEIN"]).float()
+
+ ligand_iptm_mask = (
+ maski[:, :, None]
+ * (asym_id[:, None, :] != asym_id[:, :, None])
+ * mask_pad[:, None, :]
+ * mask_pad[:, :, None]
+ * (
+ (is_ligand_token[:, :, None] * is_protein_token[:, None, :])
+ + (is_protein_token[:, :, None] * is_ligand_token[:, None, :])
+ )
+ )
+ protein_ipmt_mask = (
+ maski[:, :, None]
+ * (asym_id[:, None, :] != asym_id[:, :, None])
+ * mask_pad[:, None, :]
+ * mask_pad[:, :, None]
+ * (is_protein_token[:, :, None] * is_protein_token[:, None, :])
+ )
+
+ ligand_iptm = torch.max(
+ torch.sum(tm_expected_value * ligand_iptm_mask, dim=-1)
+ / (torch.sum(ligand_iptm_mask, dim=-1) + 1e-5),
+ dim=1,
+ ).values
+ protein_iptm = torch.max(
+ torch.sum(tm_expected_value * protein_ipmt_mask, dim=-1)
+ / (torch.sum(protein_ipmt_mask, dim=-1) + 1e-5),
+ dim=1,
+ ).values
+
+ # Compute pair chain ipTM
+ chain_pair_iptm = {}
+ asym_ids_list = torch.unique(asym_id).tolist()
+ for idx1 in asym_ids_list:
+ chain_iptm = {}
+ for idx2 in asym_ids_list:
+ mask_pair_chain = (
+ maski[:, :, None]
+ * (asym_id[:, None, :] == idx1)
+ * (asym_id[:, :, None] == idx2)
+ * mask_pad[:, None, :]
+ * mask_pad[:, :, None]
+ )
+
+ chain_iptm[idx2] = torch.max(
+ torch.sum(tm_expected_value * mask_pair_chain, dim=-1)
+ / (torch.sum(mask_pair_chain, dim=-1) + 1e-5),
+ dim=1,
+ ).values
+ chain_pair_iptm[idx1] = chain_iptm
+
+ return ptm, iptm, ligand_iptm, protein_iptm, chain_pair_iptm
diff --git a/forks/boltz/src/boltz/model/modules/confidencev2.py b/forks/boltz/src/boltz/model/modules/confidencev2.py
new file mode 100644
index 00000000..3dedc5f5
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/confidencev2.py
@@ -0,0 +1,495 @@
+import torch
+from torch import nn
+from torch.nn.functional import pad
+
+import boltz.model.layers.initialize as init
+from boltz.data import const
+from boltz.model.layers.confidence_utils import (
+ compute_aggregated_metric,
+ compute_ptms,
+)
+from boltz.model.layers.pairformer import PairformerModule
+from boltz.model.modules.encodersv2 import RelativePositionEncoder
+from boltz.model.modules.trunkv2 import (
+ ContactConditioning,
+)
+from boltz.model.modules.utils import LinearNoBias
+
+
+class ConfidenceModule(nn.Module):
+ """Algorithm 31"""
+
+ def __init__(
+ self,
+ token_s,
+ token_z,
+ pairformer_args: dict,
+ num_dist_bins=64,
+ token_level_confidence=True,
+ max_dist=22,
+ add_s_to_z_prod=False,
+ add_s_input_to_s=False,
+ add_z_input_to_z=False,
+ maximum_bond_distance=0,
+ bond_type_feature=False,
+ confidence_args: dict = None,
+ compile_pairformer=False,
+ fix_sym_check=False,
+ cyclic_pos_enc=False,
+ return_latent_feats=False,
+ conditioning_cutoff_min=None,
+ conditioning_cutoff_max=None,
+ **kwargs,
+ ):
+ super().__init__()
+ self.max_num_atoms_per_token = 23
+ self.no_update_s = pairformer_args.get("no_update_s", False)
+ boundaries = torch.linspace(2, max_dist, num_dist_bins - 1)
+ self.register_buffer("boundaries", boundaries)
+ self.dist_bin_pairwise_embed = nn.Embedding(num_dist_bins, token_z)
+ init.gating_init_(self.dist_bin_pairwise_embed.weight)
+ self.token_level_confidence = token_level_confidence
+
+ self.s_to_z = LinearNoBias(token_s, token_z)
+ self.s_to_z_transpose = LinearNoBias(token_s, token_z)
+ init.gating_init_(self.s_to_z.weight)
+ init.gating_init_(self.s_to_z_transpose.weight)
+
+ self.add_s_to_z_prod = add_s_to_z_prod
+ if add_s_to_z_prod:
+ self.s_to_z_prod_in1 = LinearNoBias(token_s, token_z)
+ self.s_to_z_prod_in2 = LinearNoBias(token_s, token_z)
+ self.s_to_z_prod_out = LinearNoBias(token_z, token_z)
+ init.gating_init_(self.s_to_z_prod_out.weight)
+
+ self.s_inputs_norm = nn.LayerNorm(token_s)
+ if not self.no_update_s:
+ self.s_norm = nn.LayerNorm(token_s)
+ self.z_norm = nn.LayerNorm(token_z)
+
+ self.add_s_input_to_s = add_s_input_to_s
+ if add_s_input_to_s:
+ self.s_input_to_s = LinearNoBias(token_s, token_s)
+ init.gating_init_(self.s_input_to_s.weight)
+
+ self.add_z_input_to_z = add_z_input_to_z
+ if add_z_input_to_z:
+ self.rel_pos = RelativePositionEncoder(
+ token_z, fix_sym_check=fix_sym_check, cyclic_pos_enc=cyclic_pos_enc
+ )
+ self.token_bonds = nn.Linear(
+ 1 if maximum_bond_distance == 0 else maximum_bond_distance + 2,
+ token_z,
+ bias=False,
+ )
+ self.bond_type_feature = bond_type_feature
+ if bond_type_feature:
+ self.token_bonds_type = nn.Embedding(len(const.bond_types) + 1, token_z)
+
+ self.contact_conditioning = ContactConditioning(
+ token_z=token_z,
+ cutoff_min=conditioning_cutoff_min,
+ cutoff_max=conditioning_cutoff_max,
+ )
+ pairformer_args["v2"] = True
+ self.pairformer_stack = PairformerModule(
+ token_s,
+ token_z,
+ **pairformer_args,
+ )
+ self.return_latent_feats = return_latent_feats
+
+ self.confidence_heads = ConfidenceHeads(
+ token_s,
+ token_z,
+ token_level_confidence=token_level_confidence,
+ **confidence_args,
+ )
+
+ def forward(
+ self,
+ s_inputs, # Float['b n ts']
+ s, # Float['b n ts']
+ z, # Float['b n n tz']
+ x_pred, # Float['bm m 3']
+ feats,
+ pred_distogram_logits,
+ multiplicity=1,
+ run_sequentially=False,
+ use_kernels: bool = False,
+ ):
+ if run_sequentially and multiplicity > 1:
+ assert z.shape[0] == 1, "Not supported with batch size > 1"
+ out_dicts = []
+ for sample_idx in range(multiplicity):
+ out_dicts.append( # noqa: PERF401
+ self.forward(
+ s_inputs,
+ s,
+ z,
+ x_pred[sample_idx : sample_idx + 1],
+ feats,
+ pred_distogram_logits,
+ multiplicity=1,
+ run_sequentially=False,
+ use_kernels=use_kernels,
+ )
+ )
+
+ out_dict = {}
+ for key in out_dicts[0]:
+ if key != "pair_chains_iptm":
+ out_dict[key] = torch.cat([out[key] for out in out_dicts], dim=0)
+ else:
+ pair_chains_iptm = {}
+ for chain_idx1 in out_dicts[0][key]:
+ chains_iptm = {}
+ for chain_idx2 in out_dicts[0][key][chain_idx1]:
+ chains_iptm[chain_idx2] = torch.cat(
+ [out[key][chain_idx1][chain_idx2] for out in out_dicts],
+ dim=0,
+ )
+ pair_chains_iptm[chain_idx1] = chains_iptm
+ out_dict[key] = pair_chains_iptm
+ return out_dict
+
+ s_inputs = self.s_inputs_norm(s_inputs)
+ if not self.no_update_s:
+ s = self.s_norm(s)
+
+ if self.add_s_input_to_s:
+ s = s + self.s_input_to_s(s_inputs)
+
+ z = self.z_norm(z)
+
+ if self.add_z_input_to_z:
+ relative_position_encoding = self.rel_pos(feats)
+ z = z + relative_position_encoding
+ z = z + self.token_bonds(feats["token_bonds"].float())
+ if self.bond_type_feature:
+ z = z + self.token_bonds_type(feats["type_bonds"].long())
+ z = z + self.contact_conditioning(feats)
+
+ s = s.repeat_interleave(multiplicity, 0)
+
+ z = (
+ z
+ + self.s_to_z(s_inputs)[:, :, None, :]
+ + self.s_to_z_transpose(s_inputs)[:, None, :, :]
+ )
+ if self.add_s_to_z_prod:
+ z = z + self.s_to_z_prod_out(
+ self.s_to_z_prod_in1(s_inputs)[:, :, None, :]
+ * self.s_to_z_prod_in2(s_inputs)[:, None, :, :]
+ )
+
+ z = z.repeat_interleave(multiplicity, 0)
+ s_inputs = s_inputs.repeat_interleave(multiplicity, 0)
+
+ token_to_rep_atom = feats["token_to_rep_atom"]
+ token_to_rep_atom = token_to_rep_atom.repeat_interleave(multiplicity, 0)
+ if len(x_pred.shape) == 4:
+ B, mult, N, _ = x_pred.shape
+ x_pred = x_pred.reshape(B * mult, N, -1)
+ else:
+ BM, N, _ = x_pred.shape
+ x_pred_repr = torch.bmm(token_to_rep_atom.float(), x_pred)
+ d = torch.cdist(x_pred_repr, x_pred_repr)
+ distogram = (d.unsqueeze(-1) > self.boundaries).sum(dim=-1).long()
+ distogram = self.dist_bin_pairwise_embed(distogram)
+ z = z + distogram
+
+ mask = feats["token_pad_mask"].repeat_interleave(multiplicity, 0)
+ pair_mask = mask[:, :, None] * mask[:, None, :]
+
+ s_t, z_t = self.pairformer_stack(
+ s, z, mask=mask, pair_mask=pair_mask, use_kernels=use_kernels
+ )
+
+ # AF3 has residual connections, we remove them
+ s = s_t
+ z = z_t
+
+ out_dict = {}
+
+ if self.return_latent_feats:
+ out_dict["s_conf"] = s
+ out_dict["z_conf"] = z
+
+ # confidence heads
+ out_dict.update(
+ self.confidence_heads(
+ s=s,
+ z=z,
+ x_pred=x_pred,
+ d=d,
+ feats=feats,
+ multiplicity=multiplicity,
+ pred_distogram_logits=pred_distogram_logits,
+ )
+ )
+ return out_dict
+
+
+class ConfidenceHeads(nn.Module):
+ def __init__(
+ self,
+ token_s,
+ token_z,
+ num_plddt_bins=50,
+ num_pde_bins=64,
+ num_pae_bins=64,
+ token_level_confidence=True,
+ use_separate_heads: bool = False,
+ **kwargs,
+ ):
+ super().__init__()
+ self.max_num_atoms_per_token = 23
+ self.token_level_confidence = token_level_confidence
+ self.use_separate_heads = use_separate_heads
+
+ if self.use_separate_heads:
+ self.to_pae_intra_logits = LinearNoBias(token_z, num_pae_bins)
+ self.to_pae_inter_logits = LinearNoBias(token_z, num_pae_bins)
+ else:
+ self.to_pae_logits = LinearNoBias(token_z, num_pae_bins)
+
+ if self.use_separate_heads:
+ self.to_pde_intra_logits = LinearNoBias(token_z, num_pde_bins)
+ self.to_pde_inter_logits = LinearNoBias(token_z, num_pde_bins)
+ else:
+ self.to_pde_logits = LinearNoBias(token_z, num_pde_bins)
+
+ if self.token_level_confidence:
+ self.to_plddt_logits = LinearNoBias(token_s, num_plddt_bins)
+ self.to_resolved_logits = LinearNoBias(token_s, 2)
+ else:
+ self.to_plddt_logits = LinearNoBias(
+ token_s, num_plddt_bins * self.max_num_atoms_per_token
+ )
+ self.to_resolved_logits = LinearNoBias(
+ token_s, 2 * self.max_num_atoms_per_token
+ )
+
+ def forward(
+ self,
+ s, # Float['b n ts']
+ z, # Float['b n n tz']
+ x_pred, # Float['bm m 3']
+ d,
+ feats,
+ pred_distogram_logits,
+ multiplicity=1,
+ ):
+ if self.use_separate_heads:
+ asym_id_token = feats["asym_id"]
+ is_same_chain = asym_id_token.unsqueeze(-1) == asym_id_token.unsqueeze(-2)
+ is_different_chain = ~is_same_chain
+
+ if self.use_separate_heads:
+ pae_intra_logits = self.to_pae_intra_logits(z)
+ pae_intra_logits = pae_intra_logits * is_same_chain.float().unsqueeze(-1)
+
+ pae_inter_logits = self.to_pae_inter_logits(z)
+ pae_inter_logits = pae_inter_logits * is_different_chain.float().unsqueeze(
+ -1
+ )
+
+ pae_logits = pae_inter_logits + pae_intra_logits
+ else:
+ pae_logits = self.to_pae_logits(z)
+
+ if self.use_separate_heads:
+ pde_intra_logits = self.to_pde_intra_logits(z + z.transpose(1, 2))
+ pde_intra_logits = pde_intra_logits * is_same_chain.float().unsqueeze(-1)
+
+ pde_inter_logits = self.to_pde_inter_logits(z + z.transpose(1, 2))
+ pde_inter_logits = pde_inter_logits * is_different_chain.float().unsqueeze(
+ -1
+ )
+
+ pde_logits = pde_inter_logits + pde_intra_logits
+ else:
+ pde_logits = self.to_pde_logits(z + z.transpose(1, 2))
+ resolved_logits = self.to_resolved_logits(s)
+ plddt_logits = self.to_plddt_logits(s)
+
+ ligand_weight = 20
+ non_interface_weight = 1
+ interface_weight = 10
+
+ token_type = feats["mol_type"]
+ token_type = token_type.repeat_interleave(multiplicity, 0)
+ is_ligand_token = (token_type == const.chain_type_ids["NONPOLYMER"]).float()
+
+ if self.token_level_confidence:
+ plddt = compute_aggregated_metric(plddt_logits)
+ token_pad_mask = feats["token_pad_mask"].repeat_interleave(multiplicity, 0)
+ complex_plddt = (plddt * token_pad_mask).sum(dim=-1) / token_pad_mask.sum(
+ dim=-1
+ )
+
+ is_contact = (d < 8).float()
+ is_different_chain = (
+ feats["asym_id"].unsqueeze(-1) != feats["asym_id"].unsqueeze(-2)
+ ).float()
+ is_different_chain = is_different_chain.repeat_interleave(multiplicity, 0)
+ token_interface_mask = torch.max(
+ is_contact * is_different_chain * (1 - is_ligand_token).unsqueeze(-1),
+ dim=-1,
+ ).values
+ token_non_interface_mask = (1 - token_interface_mask) * (
+ 1 - is_ligand_token
+ )
+ iplddt_weight = (
+ is_ligand_token * ligand_weight
+ + token_interface_mask * interface_weight
+ + token_non_interface_mask * non_interface_weight
+ )
+ complex_iplddt = (plddt * token_pad_mask * iplddt_weight).sum(
+ dim=-1
+ ) / torch.sum(token_pad_mask * iplddt_weight, dim=-1)
+
+ else:
+ # token to atom conversion for resolved logits
+ B, N, _ = resolved_logits.shape
+ resolved_logits = resolved_logits.reshape(
+ B, N, self.max_num_atoms_per_token, 2
+ )
+
+ arange_max_num_atoms = (
+ torch.arange(self.max_num_atoms_per_token)
+ .reshape(1, 1, -1)
+ .to(resolved_logits.device)
+ )
+ max_num_atoms_mask = (
+ feats["atom_to_token"].sum(1).unsqueeze(-1) > arange_max_num_atoms
+ )
+ resolved_logits = resolved_logits[:, max_num_atoms_mask.squeeze(0)]
+ resolved_logits = pad(
+ resolved_logits,
+ (
+ 0,
+ 0,
+ 0,
+ int(
+ feats["atom_pad_mask"].shape[1]
+ - feats["atom_pad_mask"].sum().item()
+ ),
+ ),
+ value=0,
+ )
+ plddt_logits = plddt_logits.reshape(B, N, self.max_num_atoms_per_token, -1)
+ plddt_logits = plddt_logits[:, max_num_atoms_mask.squeeze(0)]
+ plddt_logits = pad(
+ plddt_logits,
+ (
+ 0,
+ 0,
+ 0,
+ int(
+ feats["atom_pad_mask"].shape[1]
+ - feats["atom_pad_mask"].sum().item()
+ ),
+ ),
+ value=0,
+ )
+ atom_pad_mask = feats["atom_pad_mask"].repeat_interleave(multiplicity, 0)
+ plddt = compute_aggregated_metric(plddt_logits)
+
+ complex_plddt = (plddt * atom_pad_mask).sum(dim=-1) / atom_pad_mask.sum(
+ dim=-1
+ )
+ token_type = feats["mol_type"].float()
+ atom_to_token = feats["atom_to_token"].float()
+ chain_id_token = feats["asym_id"].float()
+ atom_type = torch.bmm(atom_to_token, token_type.unsqueeze(-1)).squeeze(-1)
+ is_ligand_atom = (atom_type == const.chain_type_ids["NONPOLYMER"]).float()
+ d_atom = torch.cdist(x_pred, x_pred)
+ is_contact = (d_atom < 8).float()
+ chain_id_atom = torch.bmm(
+ atom_to_token, chain_id_token.unsqueeze(-1)
+ ).squeeze(-1)
+ is_different_chain = (
+ chain_id_atom.unsqueeze(-1) != chain_id_atom.unsqueeze(-2)
+ ).float()
+
+ atom_interface_mask = torch.max(
+ is_contact * is_different_chain * (1 - is_ligand_atom).unsqueeze(-1),
+ dim=-1,
+ ).values
+ atom_non_interface_mask = (1 - atom_interface_mask) * (1 - is_ligand_atom)
+ iplddt_weight = (
+ is_ligand_atom * ligand_weight
+ + atom_interface_mask * interface_weight
+ + atom_non_interface_mask * non_interface_weight
+ )
+
+ complex_iplddt = (plddt * feats["atom_pad_mask"] * iplddt_weight).sum(
+ dim=-1
+ ) / torch.sum(feats["atom_pad_mask"] * iplddt_weight, dim=-1)
+
+ # Compute the gPDE and giPDE
+ pde = compute_aggregated_metric(pde_logits, end=32)
+ pred_distogram_prob = nn.functional.softmax(
+ pred_distogram_logits, dim=-1
+ ).repeat_interleave(multiplicity, 0)
+ contacts = torch.zeros((1, 1, 1, 64), dtype=pred_distogram_prob.dtype).to(
+ pred_distogram_prob.device
+ )
+ contacts[:, :, :, :20] = 1.0
+ prob_contact = (pred_distogram_prob * contacts).sum(-1)
+ token_pad_mask = feats["token_pad_mask"].repeat_interleave(multiplicity, 0)
+ token_pad_pair_mask = (
+ token_pad_mask.unsqueeze(-1)
+ * token_pad_mask.unsqueeze(-2)
+ * (
+ 1
+ - torch.eye(
+ token_pad_mask.shape[1], device=token_pad_mask.device
+ ).unsqueeze(0)
+ )
+ )
+ token_pair_mask = token_pad_pair_mask * prob_contact
+ complex_pde = (pde * token_pair_mask).sum(dim=(1, 2)) / token_pair_mask.sum(
+ dim=(1, 2)
+ )
+ asym_id = feats["asym_id"].repeat_interleave(multiplicity, 0)
+ token_interface_pair_mask = token_pair_mask * (
+ asym_id.unsqueeze(-1) != asym_id.unsqueeze(-2)
+ )
+ complex_ipde = (pde * token_interface_pair_mask).sum(dim=(1, 2)) / (
+ token_interface_pair_mask.sum(dim=(1, 2)) + 1e-5
+ )
+ out_dict = dict(
+ pde_logits=pde_logits,
+ plddt_logits=plddt_logits,
+ resolved_logits=resolved_logits,
+ pde=pde,
+ plddt=plddt,
+ complex_plddt=complex_plddt,
+ complex_iplddt=complex_iplddt,
+ complex_pde=complex_pde,
+ complex_ipde=complex_ipde,
+ )
+ out_dict["pae_logits"] = pae_logits
+ out_dict["pae"] = compute_aggregated_metric(pae_logits, end=32)
+
+ try:
+ ptm, iptm, ligand_iptm, protein_iptm, pair_chains_iptm = compute_ptms(
+ pae_logits, x_pred, feats, multiplicity
+ )
+ out_dict["ptm"] = ptm
+ out_dict["iptm"] = iptm
+ out_dict["ligand_iptm"] = ligand_iptm
+ out_dict["protein_iptm"] = protein_iptm
+ out_dict["pair_chains_iptm"] = pair_chains_iptm
+ except Exception as e:
+ print(f"Error in compute_ptms: {e}")
+ out_dict["ptm"] = torch.zeros_like(complex_plddt)
+ out_dict["iptm"] = torch.zeros_like(complex_plddt)
+ out_dict["ligand_iptm"] = torch.zeros_like(complex_plddt)
+ out_dict["protein_iptm"] = torch.zeros_like(complex_plddt)
+ out_dict["pair_chains_iptm"] = torch.zeros_like(complex_plddt)
+
+ return out_dict
diff --git a/forks/boltz/src/boltz/model/modules/diffusion.py b/forks/boltz/src/boltz/model/modules/diffusion.py
new file mode 100644
index 00000000..d209f288
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/diffusion.py
@@ -0,0 +1,863 @@
+# started from code from https://github.com/lucidrains/alphafold3-pytorch, MIT License, Copyright (c) 2024 Phil Wang
+
+from __future__ import annotations
+
+from math import sqrt
+
+import torch
+import torch.nn.functional as F
+from einops import rearrange
+from torch import nn
+from torch.nn import Module
+
+import boltz.model.layers.initialize as init
+from boltz.data import const
+from boltz.model.loss.diffusion import (
+ smooth_lddt_loss,
+ weighted_rigid_align,
+)
+from boltz.model.modules.utils import center_random_augmentation
+from boltz.model.modules.encoders import (
+ AtomAttentionDecoder,
+ AtomAttentionEncoder,
+ FourierEmbedding,
+ PairwiseConditioning,
+ SingleConditioning,
+)
+from boltz.model.modules.transformers import (
+ ConditionedTransitionBlock,
+ DiffusionTransformer,
+)
+from boltz.model.modules.utils import (
+ LinearNoBias,
+ compute_random_augmentation,
+ center_random_augmentation,
+ default,
+ log,
+)
+from boltz.model.potentials.potentials import get_potentials
+
+
+class DiffusionModule(Module):
+ """Diffusion module"""
+
+ def __init__(
+ self,
+ token_s: int,
+ token_z: int,
+ atom_s: int,
+ atom_z: int,
+ atoms_per_window_queries: int = 32,
+ atoms_per_window_keys: int = 128,
+ sigma_data: int = 16,
+ dim_fourier: int = 256,
+ atom_encoder_depth: int = 3,
+ atom_encoder_heads: int = 4,
+ token_transformer_depth: int = 24,
+ token_transformer_heads: int = 8,
+ atom_decoder_depth: int = 3,
+ atom_decoder_heads: int = 4,
+ atom_feature_dim: int = 128,
+ conditioning_transition_layers: int = 2,
+ activation_checkpointing: bool = False,
+ offload_to_cpu: bool = False,
+ **kwargs,
+ ) -> None:
+ """Initialize the diffusion module.
+
+ Parameters
+ ----------
+ token_s : int
+ The single representation dimension.
+ token_z : int
+ The pair representation dimension.
+ atom_s : int
+ The atom single representation dimension.
+ atom_z : int
+ The atom pair representation dimension.
+ atoms_per_window_queries : int, optional
+ The number of atoms per window for queries, by default 32.
+ atoms_per_window_keys : int, optional
+ The number of atoms per window for keys, by default 128.
+ sigma_data : int, optional
+ The standard deviation of the data distribution, by default 16.
+ dim_fourier : int, optional
+ The dimension of the fourier embedding, by default 256.
+ atom_encoder_depth : int, optional
+ The depth of the atom encoder, by default 3.
+ atom_encoder_heads : int, optional
+ The number of heads in the atom encoder, by default 4.
+ token_transformer_depth : int, optional
+ The depth of the token transformer, by default 24.
+ token_transformer_heads : int, optional
+ The number of heads in the token transformer, by default 8.
+ atom_decoder_depth : int, optional
+ The depth of the atom decoder, by default 3.
+ atom_decoder_heads : int, optional
+ The number of heads in the atom decoder, by default 4.
+ atom_feature_dim : int, optional
+ The atom feature dimension, by default 128.
+ conditioning_transition_layers : int, optional
+ The number of transition layers for conditioning, by default 2.
+ activation_checkpointing : bool, optional
+ Whether to use activation checkpointing, by default False.
+ offload_to_cpu : bool, optional
+ Whether to offload the activations to CPU, by default False.
+
+ """
+ super().__init__()
+
+ self.atoms_per_window_queries = atoms_per_window_queries
+ self.atoms_per_window_keys = atoms_per_window_keys
+ self.sigma_data = sigma_data
+
+ self.single_conditioner = SingleConditioning(
+ sigma_data=sigma_data,
+ token_s=token_s,
+ dim_fourier=dim_fourier,
+ num_transitions=conditioning_transition_layers,
+ )
+ self.pairwise_conditioner = PairwiseConditioning(
+ token_z=token_z,
+ dim_token_rel_pos_feats=token_z,
+ num_transitions=conditioning_transition_layers,
+ )
+
+ self.atom_attention_encoder = AtomAttentionEncoder(
+ atom_s=atom_s,
+ atom_z=atom_z,
+ token_s=token_s,
+ token_z=token_z,
+ atoms_per_window_queries=atoms_per_window_queries,
+ atoms_per_window_keys=atoms_per_window_keys,
+ atom_feature_dim=atom_feature_dim,
+ atom_encoder_depth=atom_encoder_depth,
+ atom_encoder_heads=atom_encoder_heads,
+ structure_prediction=True,
+ activation_checkpointing=activation_checkpointing,
+ )
+
+ self.s_to_a_linear = nn.Sequential(
+ nn.LayerNorm(2 * token_s), LinearNoBias(2 * token_s, 2 * token_s)
+ )
+ init.final_init_(self.s_to_a_linear[1].weight)
+
+ self.token_transformer = DiffusionTransformer(
+ dim=2 * token_s,
+ dim_single_cond=2 * token_s,
+ dim_pairwise=token_z,
+ depth=token_transformer_depth,
+ heads=token_transformer_heads,
+ activation_checkpointing=activation_checkpointing,
+ offload_to_cpu=offload_to_cpu,
+ )
+
+ self.a_norm = nn.LayerNorm(2 * token_s)
+
+ self.atom_attention_decoder = AtomAttentionDecoder(
+ atom_s=atom_s,
+ atom_z=atom_z,
+ token_s=token_s,
+ attn_window_queries=atoms_per_window_queries,
+ attn_window_keys=atoms_per_window_keys,
+ atom_decoder_depth=atom_decoder_depth,
+ atom_decoder_heads=atom_decoder_heads,
+ activation_checkpointing=activation_checkpointing,
+ )
+
+ def forward(
+ self,
+ s_inputs,
+ s_trunk,
+ z_trunk,
+ r_noisy,
+ times,
+ relative_position_encoding,
+ feats,
+ multiplicity=1,
+ model_cache=None,
+ ):
+ s, normed_fourier = self.single_conditioner(
+ times=times,
+ s_trunk=s_trunk.repeat_interleave(multiplicity, 0),
+ s_inputs=s_inputs.repeat_interleave(multiplicity, 0),
+ )
+
+ if model_cache is None or len(model_cache) == 0:
+ z = self.pairwise_conditioner(
+ z_trunk=z_trunk, token_rel_pos_feats=relative_position_encoding
+ )
+ else:
+ z = None
+
+ # Compute Atom Attention Encoder and aggregation to coarse-grained tokens
+ a, q_skip, c_skip, p_skip, to_keys = self.atom_attention_encoder(
+ feats=feats,
+ s_trunk=s_trunk,
+ z=z,
+ r=r_noisy,
+ multiplicity=multiplicity,
+ model_cache=model_cache,
+ )
+
+ # Full self-attention on token level
+ a = a + self.s_to_a_linear(s)
+
+ mask = feats["token_pad_mask"].repeat_interleave(multiplicity, 0)
+ a = self.token_transformer(
+ a,
+ mask=mask.float(),
+ s=s,
+ z=z, # note z is not expanded with multiplicity until after bias is computed
+ multiplicity=multiplicity,
+ model_cache=model_cache,
+ )
+ a = self.a_norm(a)
+
+ # Broadcast token activations to atoms and run Sequence-local Atom Attention
+ r_update = self.atom_attention_decoder(
+ a=a,
+ q=q_skip,
+ c=c_skip,
+ p=p_skip,
+ feats=feats,
+ multiplicity=multiplicity,
+ to_keys=to_keys,
+ model_cache=model_cache,
+ )
+
+ return {"r_update": r_update, "token_a": a.detach()}
+
+
+class OutTokenFeatUpdate(Module):
+ """Output token feature update"""
+
+ def __init__(
+ self,
+ sigma_data: float,
+ token_s=384,
+ dim_fourier=256,
+ ):
+ """Initialize the Output token feature update for confidence model.
+
+ Parameters
+ ----------
+ sigma_data : float
+ The standard deviation of the data distribution.
+ token_s : int, optional
+ The token dimension, by default 384.
+ dim_fourier : int, optional
+ The dimension of the fourier embedding, by default 256.
+
+ """
+
+ super().__init__()
+ self.sigma_data = sigma_data
+
+ self.norm_next = nn.LayerNorm(2 * token_s)
+ self.fourier_embed = FourierEmbedding(dim_fourier)
+ self.norm_fourier = nn.LayerNorm(dim_fourier)
+ self.transition_block = ConditionedTransitionBlock(
+ 2 * token_s, 2 * token_s + dim_fourier
+ )
+
+ def forward(
+ self,
+ times,
+ acc_a,
+ next_a,
+ ):
+ next_a = self.norm_next(next_a)
+ fourier_embed = self.fourier_embed(times)
+ normed_fourier = (
+ self.norm_fourier(fourier_embed)
+ .unsqueeze(1)
+ .expand(-1, next_a.shape[1], -1)
+ )
+ cond_a = torch.cat((acc_a, normed_fourier), dim=-1)
+
+ acc_a = acc_a + self.transition_block(next_a, cond_a)
+
+ return acc_a
+
+
+class AtomDiffusion(Module):
+ """Atom diffusion module"""
+
+ def __init__(
+ self,
+ score_model_args,
+ num_sampling_steps=5,
+ sigma_min=0.0004,
+ sigma_max=160.0,
+ sigma_data=16.0,
+ rho=7,
+ P_mean=-1.2,
+ P_std=1.5,
+ gamma_0=0.8,
+ gamma_min=1.0,
+ noise_scale=1.003,
+ step_scale=1.5,
+ coordinate_augmentation=True,
+ compile_score=False,
+ alignment_reverse_diff=False,
+ synchronize_sigmas=False,
+ use_inference_model_cache=False,
+ accumulate_token_repr=False,
+ **kwargs,
+ ):
+ """Initialize the atom diffusion module.
+
+ Parameters
+ ----------
+ score_model_args : dict
+ The arguments for the score model.
+ num_sampling_steps : int, optional
+ The number of sampling steps, by default 5.
+ sigma_min : float, optional
+ The minimum sigma value, by default 0.0004.
+ sigma_max : float, optional
+ The maximum sigma value, by default 160.0.
+ sigma_data : float, optional
+ The standard deviation of the data distribution, by default 16.0.
+ rho : int, optional
+ The rho value, by default 7.
+ P_mean : float, optional
+ The mean value of P, by default -1.2.
+ P_std : float, optional
+ The standard deviation of P, by default 1.5.
+ gamma_0 : float, optional
+ The gamma value, by default 0.8.
+ gamma_min : float, optional
+ The minimum gamma value, by default 1.0.
+ noise_scale : float, optional
+ The noise scale, by default 1.003.
+ step_scale : float, optional
+ The step scale, by default 1.5.
+ coordinate_augmentation : bool, optional
+ Whether to use coordinate augmentation, by default True.
+ compile_score : bool, optional
+ Whether to compile the score model, by default False.
+ alignment_reverse_diff : bool, optional
+ Whether to use alignment reverse diff, by default False.
+ synchronize_sigmas : bool, optional
+ Whether to synchronize the sigmas, by default False.
+ use_inference_model_cache : bool, optional
+ Whether to use the inference model cache, by default False.
+ accumulate_token_repr : bool, optional
+ Whether to accumulate the token representation, by default False.
+
+ """
+ super().__init__()
+ self.score_model = DiffusionModule(
+ **score_model_args,
+ )
+ if compile_score:
+ self.score_model = torch.compile(
+ self.score_model, dynamic=False, fullgraph=False
+ )
+
+ # parameters
+ self.sigma_min = sigma_min
+ self.sigma_max = sigma_max
+ self.sigma_data = sigma_data
+ self.rho = rho
+ self.P_mean = P_mean
+ self.P_std = P_std
+ self.num_sampling_steps = num_sampling_steps
+ self.gamma_0 = gamma_0
+ self.gamma_min = gamma_min
+ self.noise_scale = noise_scale
+ self.step_scale = step_scale
+ self.coordinate_augmentation = coordinate_augmentation
+ self.alignment_reverse_diff = alignment_reverse_diff
+ self.synchronize_sigmas = synchronize_sigmas
+ self.use_inference_model_cache = use_inference_model_cache
+
+ self.accumulate_token_repr = accumulate_token_repr
+ self.token_s = score_model_args["token_s"]
+ if self.accumulate_token_repr:
+ self.out_token_feat_update = OutTokenFeatUpdate(
+ sigma_data=sigma_data,
+ token_s=score_model_args["token_s"],
+ dim_fourier=score_model_args["dim_fourier"],
+ )
+
+ self.register_buffer("zero", torch.tensor(0.0), persistent=False)
+
+ @property
+ def device(self):
+ return next(self.score_model.parameters()).device
+
+ def c_skip(self, sigma):
+ return (self.sigma_data**2) / (sigma**2 + self.sigma_data**2)
+
+ def c_out(self, sigma):
+ return sigma * self.sigma_data / torch.sqrt(self.sigma_data**2 + sigma**2)
+
+ def c_in(self, sigma):
+ return 1 / torch.sqrt(sigma**2 + self.sigma_data**2)
+
+ def c_noise(self, sigma):
+ return log(sigma / self.sigma_data) * 0.25
+
+ def preconditioned_network_forward(
+ self,
+ noised_atom_coords,
+ sigma,
+ network_condition_kwargs: dict,
+ training: bool = True,
+ ):
+ batch, device = noised_atom_coords.shape[0], noised_atom_coords.device
+
+ if isinstance(sigma, float):
+ sigma = torch.full((batch,), sigma, device=device)
+
+ padded_sigma = rearrange(sigma, "b -> b 1 1")
+
+ net_out = self.score_model(
+ r_noisy=self.c_in(padded_sigma) * noised_atom_coords,
+ times=self.c_noise(sigma),
+ **network_condition_kwargs,
+ )
+
+ denoised_coords = (
+ self.c_skip(padded_sigma) * noised_atom_coords
+ + self.c_out(padded_sigma) * net_out["r_update"]
+ )
+ return denoised_coords, net_out["token_a"]
+
+ def sample_schedule(self, num_sampling_steps=None):
+ num_sampling_steps = default(num_sampling_steps, self.num_sampling_steps)
+ inv_rho = 1 / self.rho
+
+ steps = torch.arange(
+ num_sampling_steps, device=self.device, dtype=torch.float32
+ )
+ sigmas = (
+ self.sigma_max**inv_rho
+ + steps
+ / (num_sampling_steps - 1)
+ * (self.sigma_min**inv_rho - self.sigma_max**inv_rho)
+ ) ** self.rho
+
+ sigmas = sigmas * self.sigma_data
+
+ sigmas = F.pad(sigmas, (0, 1), value=0.0) # last step is sigma value of 0.
+ return sigmas
+
+ def sample(
+ self,
+ atom_mask,
+ num_sampling_steps=None,
+ multiplicity=1,
+ max_parallel_samples=None,
+ train_accumulate_token_repr=False,
+ steering_args=None,
+ **network_condition_kwargs,
+ ):
+ if steering_args is not None and (
+ steering_args["fk_steering"] or steering_args["physical_guidance_update"]
+ ):
+ potentials = get_potentials(steering_args, boltz2=False)
+ if steering_args is not None and steering_args["fk_steering"]:
+ multiplicity = multiplicity * steering_args["num_particles"]
+ energy_traj = torch.empty((multiplicity, 0), device=self.device)
+ resample_weights = torch.ones(multiplicity, device=self.device).reshape(
+ -1, steering_args["num_particles"]
+ )
+ if steering_args is not None and steering_args["physical_guidance_update"]:
+ scaled_guidance_update = torch.zeros(
+ (multiplicity, *atom_mask.shape[1:], 3),
+ dtype=torch.float32,
+ device=self.device,
+ )
+
+ num_sampling_steps = default(num_sampling_steps, self.num_sampling_steps)
+ atom_mask = atom_mask.repeat_interleave(multiplicity, 0)
+
+ shape = (*atom_mask.shape, 3)
+ token_repr_shape = (
+ multiplicity,
+ network_condition_kwargs["feats"]["token_index"].shape[1],
+ 2 * self.token_s,
+ )
+
+ # get the schedule, which is returned as (sigma, gamma) tuple, and pair up with the next sigma and gamma
+ sigmas = self.sample_schedule(num_sampling_steps)
+ gammas = torch.where(sigmas > self.gamma_min, self.gamma_0, 0.0)
+ sigmas_and_gammas = list(zip(sigmas[:-1], sigmas[1:], gammas[1:]))
+
+ # atom position is noise at the beginning
+ init_sigma = sigmas[0]
+ atom_coords = init_sigma * torch.randn(shape, device=self.device)
+ atom_coords_denoised = None
+ model_cache = {} if self.use_inference_model_cache else None
+
+ token_repr = None
+ token_a = None
+
+ # gradually denoise
+ for step_idx, (sigma_tm, sigma_t, gamma) in enumerate(sigmas_and_gammas):
+ random_R, random_tr = compute_random_augmentation(
+ multiplicity, device=atom_coords.device, dtype=atom_coords.dtype
+ )
+ atom_coords = atom_coords - atom_coords.mean(dim=-2, keepdims=True)
+ atom_coords = (
+ torch.einsum("bmd,bds->bms", atom_coords, random_R) + random_tr
+ )
+ if atom_coords_denoised is not None:
+ atom_coords_denoised -= atom_coords_denoised.mean(dim=-2, keepdims=True)
+ atom_coords_denoised = (
+ torch.einsum("bmd,bds->bms", atom_coords_denoised, random_R)
+ + random_tr
+ )
+ if (
+ steering_args is not None
+ and steering_args["physical_guidance_update"]
+ and scaled_guidance_update is not None
+ ):
+ scaled_guidance_update = torch.einsum(
+ "bmd,bds->bms", scaled_guidance_update, random_R
+ )
+
+ sigma_tm, sigma_t, gamma = sigma_tm.item(), sigma_t.item(), gamma.item()
+
+ t_hat = sigma_tm * (1 + gamma)
+ steering_t = 1.0 - (step_idx / num_sampling_steps)
+ noise_var = self.noise_scale**2 * (t_hat**2 - sigma_tm**2)
+ eps = sqrt(noise_var) * torch.randn(shape, device=self.device)
+ atom_coords_noisy = atom_coords + eps
+
+ with torch.no_grad():
+ atom_coords_denoised = torch.zeros_like(atom_coords_noisy)
+ token_a = torch.zeros(token_repr_shape).to(atom_coords_noisy)
+
+ sample_ids = torch.arange(multiplicity).to(atom_coords_noisy.device)
+ sample_ids_chunks = sample_ids.chunk(
+ multiplicity % max_parallel_samples + 1
+ )
+ for sample_ids_chunk in sample_ids_chunks:
+ atom_coords_denoised_chunk, token_a_chunk = (
+ self.preconditioned_network_forward(
+ atom_coords_noisy[sample_ids_chunk],
+ t_hat,
+ training=False,
+ network_condition_kwargs=dict(
+ multiplicity=sample_ids_chunk.numel(),
+ model_cache=model_cache,
+ **network_condition_kwargs,
+ ),
+ )
+ )
+ atom_coords_denoised[sample_ids_chunk] = atom_coords_denoised_chunk
+ token_a[sample_ids_chunk] = token_a_chunk
+
+ if (
+ steering_args is not None
+ and steering_args["fk_steering"]
+ and (
+ (
+ step_idx % steering_args["fk_resampling_interval"] == 0
+ and noise_var > 0
+ )
+ or step_idx == num_sampling_steps - 1
+ )
+ ):
+ # Compute energy of x_0 prediction
+ energy = torch.zeros(multiplicity, device=self.device)
+ for potential in potentials:
+ parameters = potential.compute_parameters(steering_t)
+ if parameters["resampling_weight"] > 0:
+ component_energy = potential.compute(
+ atom_coords_denoised,
+ network_condition_kwargs["feats"],
+ parameters,
+ )
+ energy += parameters["resampling_weight"] * component_energy
+ energy_traj = torch.cat((energy_traj, energy.unsqueeze(1)), dim=1)
+
+ # Compute log G values
+ if step_idx == 0:
+ log_G = -1 * energy
+ else:
+ log_G = energy_traj[:, -2] - energy_traj[:, -1]
+
+ # Compute ll difference between guided and unguided transition distribution
+ if steering_args["physical_guidance_update"] and noise_var > 0:
+ ll_difference = (
+ eps**2 - (eps + scaled_guidance_update) ** 2
+ ).sum(dim=(-1, -2)) / (2 * noise_var)
+ else:
+ ll_difference = torch.zeros_like(energy)
+
+ # Compute resampling weights
+ resample_weights = F.softmax(
+ (ll_difference + steering_args["fk_lambda"] * log_G).reshape(
+ -1, steering_args["num_particles"]
+ ),
+ dim=1,
+ )
+
+ # Compute guidance update to x_0 prediction
+ if (
+ steering_args is not None
+ and steering_args["physical_guidance_update"]
+ and step_idx < num_sampling_steps - 1
+ ):
+ guidance_update = torch.zeros_like(atom_coords_denoised)
+ for guidance_step in range(steering_args["num_gd_steps"]):
+ energy_gradient = torch.zeros_like(atom_coords_denoised)
+ for potential in potentials:
+ parameters = potential.compute_parameters(steering_t)
+ if (
+ parameters["guidance_weight"] > 0
+ and (guidance_step) % parameters["guidance_interval"]
+ == 0
+ ):
+ energy_gradient += parameters[
+ "guidance_weight"
+ ] * potential.compute_gradient(
+ atom_coords_denoised + guidance_update,
+ network_condition_kwargs["feats"],
+ parameters,
+ )
+ guidance_update -= energy_gradient
+ atom_coords_denoised += guidance_update
+ scaled_guidance_update = (
+ guidance_update
+ * -1
+ * self.step_scale
+ * (sigma_t - t_hat)
+ / t_hat
+ )
+
+ if (
+ steering_args is not None
+ and steering_args["fk_steering"]
+ and (
+ (
+ step_idx % steering_args["fk_resampling_interval"] == 0
+ and noise_var > 0
+ )
+ or step_idx == num_sampling_steps - 1
+ )
+ ):
+ resample_indices = (
+ torch.multinomial(
+ resample_weights,
+ resample_weights.shape[1]
+ if step_idx < num_sampling_steps - 1
+ else 1,
+ replacement=True,
+ )
+ + resample_weights.shape[1]
+ * torch.arange(
+ resample_weights.shape[0], device=resample_weights.device
+ ).unsqueeze(-1)
+ ).flatten()
+
+ atom_coords = atom_coords[resample_indices]
+ atom_coords_noisy = atom_coords_noisy[resample_indices]
+ atom_mask = atom_mask[resample_indices]
+ if atom_coords_denoised is not None:
+ atom_coords_denoised = atom_coords_denoised[resample_indices]
+ energy_traj = energy_traj[resample_indices]
+ if steering_args["physical_guidance_update"]:
+ scaled_guidance_update = scaled_guidance_update[
+ resample_indices
+ ]
+ if token_repr is not None:
+ token_repr = token_repr[resample_indices]
+ if token_a is not None:
+ token_a = token_a[resample_indices]
+
+ if self.accumulate_token_repr:
+ if token_repr is None:
+ token_repr = torch.zeros_like(token_a)
+
+ with torch.set_grad_enabled(train_accumulate_token_repr):
+ sigma = torch.full(
+ (atom_coords_denoised.shape[0],),
+ t_hat,
+ device=atom_coords_denoised.device,
+ )
+ token_repr = self.out_token_feat_update(
+ times=self.c_noise(sigma), acc_a=token_repr, next_a=token_a
+ )
+
+ if self.alignment_reverse_diff:
+ with torch.autocast("cuda", enabled=False):
+ atom_coords_noisy = weighted_rigid_align(
+ atom_coords_noisy.float(),
+ atom_coords_denoised.float(),
+ atom_mask.float(),
+ atom_mask.float(),
+ )
+
+ atom_coords_noisy = atom_coords_noisy.to(atom_coords_denoised)
+
+ denoised_over_sigma = (atom_coords_noisy - atom_coords_denoised) / t_hat
+ atom_coords_next = (
+ atom_coords_noisy
+ + self.step_scale * (sigma_t - t_hat) * denoised_over_sigma
+ )
+
+ atom_coords = atom_coords_next
+
+ return dict(sample_atom_coords=atom_coords, diff_token_repr=token_repr)
+
+ def loss_weight(self, sigma):
+ return (sigma**2 + self.sigma_data**2) / ((sigma * self.sigma_data) ** 2)
+
+ def noise_distribution(self, batch_size):
+ return (
+ self.sigma_data
+ * (
+ self.P_mean
+ + self.P_std * torch.randn((batch_size,), device=self.device)
+ ).exp()
+ )
+
+ def forward(
+ self,
+ s_inputs,
+ s_trunk,
+ z_trunk,
+ relative_position_encoding,
+ feats,
+ multiplicity=1,
+ ):
+ # training diffusion step
+ batch_size = feats["coords"].shape[0]
+
+ if self.synchronize_sigmas:
+ sigmas = self.noise_distribution(batch_size).repeat_interleave(
+ multiplicity, 0
+ )
+ else:
+ sigmas = self.noise_distribution(batch_size * multiplicity)
+ padded_sigmas = rearrange(sigmas, "b -> b 1 1")
+
+ atom_coords = feats["coords"]
+ B, N, L = atom_coords.shape[0:3]
+ atom_coords = atom_coords.reshape(B * N, L, 3)
+ atom_coords = atom_coords.repeat_interleave(multiplicity // N, 0)
+ feats["coords"] = atom_coords
+
+ atom_mask = feats["atom_pad_mask"]
+ atom_mask = atom_mask.repeat_interleave(multiplicity, 0)
+
+ atom_coords = center_random_augmentation(
+ atom_coords, atom_mask, augmentation=self.coordinate_augmentation
+ )
+
+ noise = torch.randn_like(atom_coords)
+ noised_atom_coords = atom_coords + padded_sigmas * noise
+
+ denoised_atom_coords, _ = self.preconditioned_network_forward(
+ noised_atom_coords,
+ sigmas,
+ training=True,
+ network_condition_kwargs=dict(
+ s_inputs=s_inputs,
+ s_trunk=s_trunk,
+ z_trunk=z_trunk,
+ relative_position_encoding=relative_position_encoding,
+ feats=feats,
+ multiplicity=multiplicity,
+ ),
+ )
+
+ return dict(
+ noised_atom_coords=noised_atom_coords,
+ denoised_atom_coords=denoised_atom_coords,
+ sigmas=sigmas,
+ aligned_true_atom_coords=atom_coords,
+ )
+
+ def compute_loss(
+ self,
+ feats,
+ out_dict,
+ add_smooth_lddt_loss=True,
+ nucleotide_loss_weight=5.0,
+ ligand_loss_weight=10.0,
+ multiplicity=1,
+ ):
+ denoised_atom_coords = out_dict["denoised_atom_coords"]
+ noised_atom_coords = out_dict["noised_atom_coords"]
+ sigmas = out_dict["sigmas"]
+
+ resolved_atom_mask = feats["atom_resolved_mask"]
+ resolved_atom_mask = resolved_atom_mask.repeat_interleave(multiplicity, 0)
+
+ align_weights = noised_atom_coords.new_ones(noised_atom_coords.shape[:2])
+ atom_type = (
+ torch.bmm(
+ feats["atom_to_token"].float(), feats["mol_type"].unsqueeze(-1).float()
+ )
+ .squeeze(-1)
+ .long()
+ )
+ atom_type_mult = atom_type.repeat_interleave(multiplicity, 0)
+
+ align_weights = align_weights * (
+ 1
+ + nucleotide_loss_weight
+ * (
+ torch.eq(atom_type_mult, const.chain_type_ids["DNA"]).float()
+ + torch.eq(atom_type_mult, const.chain_type_ids["RNA"]).float()
+ )
+ + ligand_loss_weight
+ * torch.eq(atom_type_mult, const.chain_type_ids["NONPOLYMER"]).float()
+ )
+
+ with torch.no_grad(), torch.autocast("cuda", enabled=False):
+ atom_coords = out_dict["aligned_true_atom_coords"]
+ atom_coords_aligned_ground_truth = weighted_rigid_align(
+ atom_coords.detach().float(),
+ denoised_atom_coords.detach().float(),
+ align_weights.detach().float(),
+ mask=resolved_atom_mask.detach().float(),
+ )
+
+ # Cast back
+ atom_coords_aligned_ground_truth = atom_coords_aligned_ground_truth.to(
+ denoised_atom_coords
+ )
+
+ # weighted MSE loss of denoised atom positions
+ mse_loss = ((denoised_atom_coords - atom_coords_aligned_ground_truth) ** 2).sum(
+ dim=-1
+ )
+ mse_loss = torch.sum(
+ mse_loss * align_weights * resolved_atom_mask, dim=-1
+ ) / torch.sum(3 * align_weights * resolved_atom_mask, dim=-1)
+
+ # weight by sigma factor
+ loss_weights = self.loss_weight(sigmas)
+ mse_loss = (mse_loss * loss_weights).mean()
+
+ total_loss = mse_loss
+
+ # proposed auxiliary smooth lddt loss
+ lddt_loss = self.zero
+ if add_smooth_lddt_loss:
+ lddt_loss = smooth_lddt_loss(
+ denoised_atom_coords,
+ feats["coords"],
+ torch.eq(atom_type, const.chain_type_ids["DNA"]).float()
+ + torch.eq(atom_type, const.chain_type_ids["RNA"]).float(),
+ coords_mask=feats["atom_resolved_mask"],
+ multiplicity=multiplicity,
+ )
+
+ total_loss = total_loss + lddt_loss
+
+ loss_breakdown = dict(
+ mse_loss=mse_loss,
+ smooth_lddt_loss=lddt_loss,
+ )
+
+ return dict(loss=total_loss, loss_breakdown=loss_breakdown)
diff --git a/forks/boltz/src/boltz/model/modules/diffusion_conditioning.py b/forks/boltz/src/boltz/model/modules/diffusion_conditioning.py
new file mode 100644
index 00000000..374e8278
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/diffusion_conditioning.py
@@ -0,0 +1,116 @@
+from __future__ import annotations
+
+import torch
+from torch import nn
+from torch.nn import Module
+
+from boltz.model.modules.encodersv2 import (
+ AtomEncoder,
+ PairwiseConditioning,
+)
+
+
+class DiffusionConditioning(Module):
+ def __init__(
+ self,
+ token_s: int,
+ token_z: int,
+ atom_s: int,
+ atom_z: int,
+ atoms_per_window_queries: int = 32,
+ atoms_per_window_keys: int = 128,
+ atom_encoder_depth: int = 3,
+ atom_encoder_heads: int = 4,
+ token_transformer_depth: int = 24,
+ token_transformer_heads: int = 8,
+ atom_decoder_depth: int = 3,
+ atom_decoder_heads: int = 4,
+ atom_feature_dim: int = 128,
+ conditioning_transition_layers: int = 2,
+ use_no_atom_char: bool = False,
+ use_atom_backbone_feat: bool = False,
+ use_residue_feats_atoms: bool = False,
+ ) -> None:
+ super().__init__()
+
+ self.pairwise_conditioner = PairwiseConditioning(
+ token_z=token_z,
+ dim_token_rel_pos_feats=token_z,
+ num_transitions=conditioning_transition_layers,
+ )
+
+ self.atom_encoder = AtomEncoder(
+ atom_s=atom_s,
+ atom_z=atom_z,
+ token_s=token_s,
+ token_z=token_z,
+ atoms_per_window_queries=atoms_per_window_queries,
+ atoms_per_window_keys=atoms_per_window_keys,
+ atom_feature_dim=atom_feature_dim,
+ structure_prediction=True,
+ use_no_atom_char=use_no_atom_char,
+ use_atom_backbone_feat=use_atom_backbone_feat,
+ use_residue_feats_atoms=use_residue_feats_atoms,
+ )
+
+ self.atom_enc_proj_z = nn.ModuleList()
+ for _ in range(atom_encoder_depth):
+ self.atom_enc_proj_z.append(
+ nn.Sequential(
+ nn.LayerNorm(atom_z),
+ nn.Linear(atom_z, atom_encoder_heads, bias=False),
+ )
+ )
+
+ self.atom_dec_proj_z = nn.ModuleList()
+ for _ in range(atom_decoder_depth):
+ self.atom_dec_proj_z.append(
+ nn.Sequential(
+ nn.LayerNorm(atom_z),
+ nn.Linear(atom_z, atom_decoder_heads, bias=False),
+ )
+ )
+
+ self.token_trans_proj_z = nn.ModuleList()
+ for _ in range(token_transformer_depth):
+ self.token_trans_proj_z.append(
+ nn.Sequential(
+ nn.LayerNorm(token_z),
+ nn.Linear(token_z, token_transformer_heads, bias=False),
+ )
+ )
+
+ def forward(
+ self,
+ s_trunk, # Float['b n ts']
+ z_trunk, # Float['b n n tz']
+ relative_position_encoding, # Float['b n n tz']
+ feats,
+ ):
+ z = self.pairwise_conditioner(
+ z_trunk,
+ relative_position_encoding,
+ )
+
+ q, c, p, to_keys = self.atom_encoder(
+ feats=feats,
+ s_trunk=s_trunk, # Float['b n ts'],
+ z=z, # Float['b n n tz'],
+ )
+
+ atom_enc_bias = []
+ for layer in self.atom_enc_proj_z:
+ atom_enc_bias.append(layer(p))
+ atom_enc_bias = torch.cat(atom_enc_bias, dim=-1)
+
+ atom_dec_bias = []
+ for layer in self.atom_dec_proj_z:
+ atom_dec_bias.append(layer(p))
+ atom_dec_bias = torch.cat(atom_dec_bias, dim=-1)
+
+ token_trans_bias = []
+ for layer in self.token_trans_proj_z:
+ token_trans_bias.append(layer(z))
+ token_trans_bias = torch.cat(token_trans_bias, dim=-1)
+
+ return q, c, to_keys, atom_enc_bias, atom_dec_bias, token_trans_bias
diff --git a/forks/boltz/src/boltz/model/modules/diffusionv2.py b/forks/boltz/src/boltz/model/modules/diffusionv2.py
new file mode 100644
index 00000000..fd1af56d
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/diffusionv2.py
@@ -0,0 +1,693 @@
+# started from code from https://github.com/lucidrains/alphafold3-pytorch, MIT License, Copyright (c) 2024 Phil Wang
+
+from __future__ import annotations
+
+from math import sqrt
+
+import numpy as np
+import torch
+import torch.nn.functional as F # noqa: N812
+from einops import rearrange
+from torch import nn
+from torch.nn import Module
+
+import boltz.model.layers.initialize as init
+from boltz.data import const
+from boltz.model.loss.diffusionv2 import (
+ smooth_lddt_loss,
+ weighted_rigid_align,
+)
+from boltz.model.modules.encodersv2 import (
+ AtomAttentionDecoder,
+ AtomAttentionEncoder,
+ SingleConditioning,
+)
+from boltz.model.modules.transformersv2 import (
+ DiffusionTransformer,
+)
+from boltz.model.modules.utils import (
+ LinearNoBias,
+ center_random_augmentation,
+ compute_random_augmentation,
+ default,
+ log,
+)
+from boltz.model.potentials.potentials import get_potentials
+
+
+class DiffusionModule(Module):
+ """Diffusion module"""
+
+ def __init__(
+ self,
+ token_s: int,
+ atom_s: int,
+ atoms_per_window_queries: int = 32,
+ atoms_per_window_keys: int = 128,
+ sigma_data: int = 16,
+ dim_fourier: int = 256,
+ atom_encoder_depth: int = 3,
+ atom_encoder_heads: int = 4,
+ token_transformer_depth: int = 24,
+ token_transformer_heads: int = 8,
+ atom_decoder_depth: int = 3,
+ atom_decoder_heads: int = 4,
+ conditioning_transition_layers: int = 2,
+ activation_checkpointing: bool = False,
+ transformer_post_ln: bool = False,
+ ) -> None:
+ super().__init__()
+
+ self.atoms_per_window_queries = atoms_per_window_queries
+ self.atoms_per_window_keys = atoms_per_window_keys
+ self.sigma_data = sigma_data
+ self.activation_checkpointing = activation_checkpointing
+
+ # conditioning
+ self.single_conditioner = SingleConditioning(
+ sigma_data=sigma_data,
+ token_s=token_s,
+ dim_fourier=dim_fourier,
+ num_transitions=conditioning_transition_layers,
+ )
+
+ self.atom_attention_encoder = AtomAttentionEncoder(
+ atom_s=atom_s,
+ token_s=token_s,
+ atoms_per_window_queries=atoms_per_window_queries,
+ atoms_per_window_keys=atoms_per_window_keys,
+ atom_encoder_depth=atom_encoder_depth,
+ atom_encoder_heads=atom_encoder_heads,
+ structure_prediction=True,
+ activation_checkpointing=activation_checkpointing,
+ transformer_post_layer_norm=transformer_post_ln,
+ )
+
+ self.s_to_a_linear = nn.Sequential(
+ nn.LayerNorm(2 * token_s), LinearNoBias(2 * token_s, 2 * token_s)
+ )
+ init.final_init_(self.s_to_a_linear[1].weight)
+
+ self.token_transformer = DiffusionTransformer(
+ dim=2 * token_s,
+ dim_single_cond=2 * token_s,
+ depth=token_transformer_depth,
+ heads=token_transformer_heads,
+ activation_checkpointing=activation_checkpointing,
+ # post_layer_norm=transformer_post_ln,
+ )
+
+ self.a_norm = nn.LayerNorm(
+ 2 * token_s
+ ) # if not transformer_post_ln else nn.Identity()
+
+ self.atom_attention_decoder = AtomAttentionDecoder(
+ atom_s=atom_s,
+ token_s=token_s,
+ attn_window_queries=atoms_per_window_queries,
+ attn_window_keys=atoms_per_window_keys,
+ atom_decoder_depth=atom_decoder_depth,
+ atom_decoder_heads=atom_decoder_heads,
+ activation_checkpointing=activation_checkpointing,
+ # transformer_post_layer_norm=transformer_post_ln,
+ )
+
+ def forward(
+ self,
+ s_inputs, # Float['b n ts']
+ s_trunk, # Float['b n ts']
+ r_noisy, # Float['bm m 3']
+ times, # Float['bm 1 1']
+ feats,
+ diffusion_conditioning,
+ multiplicity=1,
+ ):
+ if self.activation_checkpointing and self.training:
+ s, normed_fourier = torch.utils.checkpoint.checkpoint(
+ self.single_conditioner,
+ times,
+ s_trunk.repeat_interleave(multiplicity, 0),
+ s_inputs.repeat_interleave(multiplicity, 0),
+ )
+ else:
+ s, normed_fourier = self.single_conditioner(
+ times,
+ s_trunk.repeat_interleave(multiplicity, 0),
+ s_inputs.repeat_interleave(multiplicity, 0),
+ )
+
+ # Sequence-local Atom Attention and aggregation to coarse-grained tokens
+ a, q_skip, c_skip, to_keys = self.atom_attention_encoder(
+ feats=feats,
+ q=diffusion_conditioning["q"].float(),
+ c=diffusion_conditioning["c"].float(),
+ atom_enc_bias=diffusion_conditioning["atom_enc_bias"].float(),
+ to_keys=diffusion_conditioning["to_keys"],
+ r=r_noisy, # Float['b m 3'],
+ multiplicity=multiplicity,
+ )
+
+ # Full self-attention on token level
+ a = a + self.s_to_a_linear(s)
+
+ mask = feats["token_pad_mask"].repeat_interleave(multiplicity, 0)
+ a = self.token_transformer(
+ a,
+ mask=mask.float(),
+ s=s,
+ bias=diffusion_conditioning[
+ "token_trans_bias"
+ ].float(), # note z is not expanded with multiplicity until after bias is computed
+ multiplicity=multiplicity,
+ )
+ a = self.a_norm(a)
+
+ # Broadcast token activations to atoms and run Sequence-local Atom Attention
+ r_update = self.atom_attention_decoder(
+ a=a,
+ q=q_skip,
+ c=c_skip,
+ atom_dec_bias=diffusion_conditioning["atom_dec_bias"].float(),
+ feats=feats,
+ multiplicity=multiplicity,
+ to_keys=to_keys,
+ )
+
+ return r_update
+
+
+class AtomDiffusion(Module):
+ def __init__(
+ self,
+ score_model_args,
+ num_sampling_steps: int = 5, # number of sampling steps
+ sigma_min: float = 0.0004, # min noise level
+ sigma_max: float = 160.0, # max noise level
+ sigma_data: float = 16.0, # standard deviation of data distribution
+ rho: float = 7, # controls the sampling schedule
+ P_mean: float = -1.2, # mean of log-normal distribution from which noise is drawn for training
+ P_std: float = 1.5, # standard deviation of log-normal distribution from which noise is drawn for training
+ gamma_0: float = 0.8,
+ gamma_min: float = 1.0,
+ noise_scale: float = 1.003,
+ step_scale: float = 1.5,
+ step_scale_random: list = None,
+ coordinate_augmentation: bool = True,
+ coordinate_augmentation_inference=None,
+ compile_score: bool = False,
+ alignment_reverse_diff: bool = False,
+ synchronize_sigmas: bool = False,
+ ):
+ super().__init__()
+ self.score_model = DiffusionModule(
+ **score_model_args,
+ )
+ if compile_score:
+ self.score_model = torch.compile(
+ self.score_model, dynamic=False, fullgraph=False
+ )
+
+ # parameters
+ self.sigma_min = sigma_min
+ self.sigma_max = sigma_max
+ self.sigma_data = sigma_data
+ self.rho = rho
+ self.P_mean = P_mean
+ self.P_std = P_std
+ self.num_sampling_steps = num_sampling_steps
+ self.gamma_0 = gamma_0
+ self.gamma_min = gamma_min
+ self.noise_scale = noise_scale
+ self.step_scale = step_scale
+ self.step_scale_random = step_scale_random
+ self.coordinate_augmentation = coordinate_augmentation
+ self.coordinate_augmentation_inference = (
+ coordinate_augmentation_inference
+ if coordinate_augmentation_inference is not None
+ else coordinate_augmentation
+ )
+ self.alignment_reverse_diff = alignment_reverse_diff
+ self.synchronize_sigmas = synchronize_sigmas
+
+ self.token_s = score_model_args["token_s"]
+ self.register_buffer("zero", torch.tensor(0.0), persistent=False)
+
+ @property
+ def device(self):
+ return next(self.score_model.parameters()).device
+
+ def c_skip(self, sigma):
+ return (self.sigma_data**2) / (sigma**2 + self.sigma_data**2)
+
+ def c_out(self, sigma):
+ return sigma * self.sigma_data / torch.sqrt(self.sigma_data**2 + sigma**2)
+
+ def c_in(self, sigma):
+ return 1 / torch.sqrt(sigma**2 + self.sigma_data**2)
+
+ def c_noise(self, sigma):
+ return log(sigma / self.sigma_data) * 0.25
+
+ def preconditioned_network_forward(
+ self,
+ noised_atom_coords, #: Float['b m 3'],
+ sigma, #: Float['b'] | Float[' '] | float,
+ network_condition_kwargs: dict,
+ ):
+ batch, device = noised_atom_coords.shape[0], noised_atom_coords.device
+
+ if isinstance(sigma, float):
+ sigma = torch.full((batch,), sigma, device=device)
+
+ padded_sigma = rearrange(sigma, "b -> b 1 1")
+
+ r_update = self.score_model(
+ r_noisy=self.c_in(padded_sigma) * noised_atom_coords,
+ times=self.c_noise(sigma),
+ **network_condition_kwargs,
+ )
+
+ denoised_coords = (
+ self.c_skip(padded_sigma) * noised_atom_coords
+ + self.c_out(padded_sigma) * r_update
+ )
+ return denoised_coords
+
+ def sample_schedule(self, num_sampling_steps=None):
+ num_sampling_steps = default(num_sampling_steps, self.num_sampling_steps)
+ inv_rho = 1 / self.rho
+
+ steps = torch.arange(
+ num_sampling_steps, device=self.device, dtype=torch.float32
+ )
+ sigmas = (
+ self.sigma_max**inv_rho
+ + steps
+ / (num_sampling_steps - 1)
+ * (self.sigma_min**inv_rho - self.sigma_max**inv_rho)
+ ) ** self.rho
+
+ sigmas = sigmas * self.sigma_data
+
+ sigmas = F.pad(sigmas, (0, 1), value=0.0) # last step is sigma value of 0.
+ return sigmas
+
+ def sample(
+ self,
+ atom_mask,
+ num_sampling_steps=None,
+ multiplicity=1,
+ max_parallel_samples=None,
+ steering_args=None,
+ **network_condition_kwargs,
+ ):
+ if steering_args is not None and (
+ steering_args["fk_steering"]
+ or steering_args["physical_guidance_update"]
+ or steering_args["contact_guidance_update"]
+ ):
+ potentials = get_potentials(steering_args, boltz2=True)
+
+ if steering_args["fk_steering"]:
+ multiplicity = multiplicity * steering_args["num_particles"]
+ energy_traj = torch.empty((multiplicity, 0), device=self.device)
+ resample_weights = torch.ones(multiplicity, device=self.device).reshape(
+ -1, steering_args["num_particles"]
+ )
+ if (
+ steering_args["physical_guidance_update"]
+ or steering_args["contact_guidance_update"]
+ ):
+ scaled_guidance_update = torch.zeros(
+ (multiplicity, *atom_mask.shape[1:], 3),
+ dtype=torch.float32,
+ device=self.device,
+ )
+ if max_parallel_samples is None:
+ max_parallel_samples = multiplicity
+
+ num_sampling_steps = default(num_sampling_steps, self.num_sampling_steps)
+ atom_mask = atom_mask.repeat_interleave(multiplicity, 0)
+
+ shape = (*atom_mask.shape, 3)
+
+ # get the schedule, which is returned as (sigma, gamma) tuple, and pair up with the next sigma and gamma
+ sigmas = self.sample_schedule(num_sampling_steps)
+ gammas = torch.where(sigmas > self.gamma_min, self.gamma_0, 0.0)
+ sigmas_and_gammas = list(zip(sigmas[:-1], sigmas[1:], gammas[1:]))
+ if self.training and self.step_scale_random is not None:
+ step_scale = np.random.choice(self.step_scale_random)
+ else:
+ step_scale = self.step_scale
+
+ # atom position is noise at the beginning
+ init_sigma = sigmas[0]
+ atom_coords = init_sigma * torch.randn(shape, device=self.device)
+ token_repr = None
+ atom_coords_denoised = None
+
+ # gradually denoise
+ for step_idx, (sigma_tm, sigma_t, gamma) in enumerate(sigmas_and_gammas):
+ random_R, random_tr = compute_random_augmentation(
+ multiplicity, device=atom_coords.device, dtype=atom_coords.dtype
+ )
+ atom_coords = atom_coords - atom_coords.mean(dim=-2, keepdims=True)
+ atom_coords = (
+ torch.einsum("bmd,bds->bms", atom_coords, random_R) + random_tr
+ )
+ if atom_coords_denoised is not None:
+ atom_coords_denoised -= atom_coords_denoised.mean(dim=-2, keepdims=True)
+ atom_coords_denoised = (
+ torch.einsum("bmd,bds->bms", atom_coords_denoised, random_R)
+ + random_tr
+ )
+ if (
+ steering_args["physical_guidance_update"]
+ or steering_args["contact_guidance_update"]
+ ) and scaled_guidance_update is not None:
+ scaled_guidance_update = torch.einsum(
+ "bmd,bds->bms", scaled_guidance_update, random_R
+ )
+
+ sigma_tm, sigma_t, gamma = sigma_tm.item(), sigma_t.item(), gamma.item()
+
+ t_hat = sigma_tm * (1 + gamma)
+ steering_t = 1.0 - (step_idx / num_sampling_steps)
+ noise_var = self.noise_scale**2 * (t_hat**2 - sigma_tm**2)
+ eps = sqrt(noise_var) * torch.randn(shape, device=self.device)
+ atom_coords_noisy = atom_coords + eps
+
+ with torch.no_grad():
+ atom_coords_denoised = torch.zeros_like(atom_coords_noisy)
+ sample_ids = torch.arange(multiplicity).to(atom_coords_noisy.device)
+ sample_ids_chunks = sample_ids.chunk(
+ multiplicity % max_parallel_samples + 1
+ )
+
+ for sample_ids_chunk in sample_ids_chunks:
+ atom_coords_denoised_chunk = self.preconditioned_network_forward(
+ atom_coords_noisy[sample_ids_chunk],
+ t_hat,
+ network_condition_kwargs=dict(
+ multiplicity=sample_ids_chunk.numel(),
+ **network_condition_kwargs,
+ ),
+ )
+ atom_coords_denoised[sample_ids_chunk] = atom_coords_denoised_chunk
+
+ if steering_args["fk_steering"] and (
+ (
+ step_idx % steering_args["fk_resampling_interval"] == 0
+ and noise_var > 0
+ )
+ or step_idx == num_sampling_steps - 1
+ ):
+ # Compute energy of x_0 prediction
+ energy = torch.zeros(multiplicity, device=self.device)
+ for potential in potentials:
+ parameters = potential.compute_parameters(steering_t)
+ if parameters["resampling_weight"] > 0:
+ component_energy = potential.compute(
+ atom_coords_denoised,
+ network_condition_kwargs["feats"],
+ parameters,
+ )
+ energy += parameters["resampling_weight"] * component_energy
+ energy_traj = torch.cat((energy_traj, energy.unsqueeze(1)), dim=1)
+
+ # Compute log G values
+ if step_idx == 0:
+ log_G = -1 * energy
+ else:
+ log_G = energy_traj[:, -2] - energy_traj[:, -1]
+
+ # Compute ll difference between guided and unguided transition distribution
+ if (
+ steering_args["physical_guidance_update"]
+ or steering_args["contact_guidance_update"]
+ ) and noise_var > 0:
+ ll_difference = (
+ eps**2 - (eps + scaled_guidance_update) ** 2
+ ).sum(dim=(-1, -2)) / (2 * noise_var)
+ else:
+ ll_difference = torch.zeros_like(energy)
+
+ # Compute resampling weights
+ resample_weights = F.softmax(
+ (ll_difference + steering_args["fk_lambda"] * log_G).reshape(
+ -1, steering_args["num_particles"]
+ ),
+ dim=1,
+ )
+
+ # Compute guidance update to x_0 prediction
+ if (
+ steering_args["physical_guidance_update"]
+ or steering_args["contact_guidance_update"]
+ ) and step_idx < num_sampling_steps - 1:
+ guidance_update = torch.zeros_like(atom_coords_denoised)
+ for guidance_step in range(steering_args["num_gd_steps"]):
+ energy_gradient = torch.zeros_like(atom_coords_denoised)
+ for potential in potentials:
+ parameters = potential.compute_parameters(steering_t)
+ if (
+ parameters["guidance_weight"] > 0
+ and (guidance_step) % parameters["guidance_interval"]
+ == 0
+ ):
+ energy_gradient += parameters[
+ "guidance_weight"
+ ] * potential.compute_gradient(
+ atom_coords_denoised + guidance_update,
+ network_condition_kwargs["feats"],
+ parameters,
+ )
+ guidance_update -= energy_gradient
+ atom_coords_denoised += guidance_update
+ scaled_guidance_update = (
+ guidance_update
+ * -1
+ * self.step_scale
+ * (sigma_t - t_hat)
+ / t_hat
+ )
+
+ if steering_args["fk_steering"] and (
+ (
+ step_idx % steering_args["fk_resampling_interval"] == 0
+ and noise_var > 0
+ )
+ or step_idx == num_sampling_steps - 1
+ ):
+ resample_indices = (
+ torch.multinomial(
+ resample_weights,
+ resample_weights.shape[1]
+ if step_idx < num_sampling_steps - 1
+ else 1,
+ replacement=True,
+ )
+ + resample_weights.shape[1]
+ * torch.arange(
+ resample_weights.shape[0], device=resample_weights.device
+ ).unsqueeze(-1)
+ ).flatten()
+
+ atom_coords = atom_coords[resample_indices]
+ atom_coords_noisy = atom_coords_noisy[resample_indices]
+ atom_mask = atom_mask[resample_indices]
+ if atom_coords_denoised is not None:
+ atom_coords_denoised = atom_coords_denoised[resample_indices]
+ energy_traj = energy_traj[resample_indices]
+ if (
+ steering_args["physical_guidance_update"]
+ or steering_args["contact_guidance_update"]
+ ):
+ scaled_guidance_update = scaled_guidance_update[
+ resample_indices
+ ]
+ if token_repr is not None:
+ token_repr = token_repr[resample_indices]
+
+ if self.alignment_reverse_diff:
+ with torch.autocast("cuda", enabled=False):
+ atom_coords_noisy = weighted_rigid_align(
+ atom_coords_noisy.float(),
+ atom_coords_denoised.float(),
+ atom_mask.float(),
+ atom_mask.float(),
+ )
+
+ atom_coords_noisy = atom_coords_noisy.to(atom_coords_denoised)
+
+ denoised_over_sigma = (atom_coords_noisy - atom_coords_denoised) / t_hat
+ atom_coords_next = (
+ atom_coords_noisy + step_scale * (sigma_t - t_hat) * denoised_over_sigma
+ )
+
+ atom_coords = atom_coords_next
+
+ return dict(sample_atom_coords=atom_coords, diff_token_repr=token_repr)
+
+ def loss_weight(self, sigma):
+ return (sigma**2 + self.sigma_data**2) / ((sigma * self.sigma_data) ** 2)
+
+ def noise_distribution(self, batch_size):
+ return (
+ self.sigma_data
+ * (
+ self.P_mean
+ + self.P_std * torch.randn((batch_size,), device=self.device)
+ ).exp()
+ )
+
+ def forward(
+ self,
+ s_inputs,
+ s_trunk,
+ feats,
+ diffusion_conditioning,
+ multiplicity=1,
+ ):
+ # training diffusion step
+ batch_size = feats["coords"].shape[0] // multiplicity
+
+ if self.synchronize_sigmas:
+ sigmas = self.noise_distribution(batch_size).repeat_interleave(
+ multiplicity, 0
+ )
+ else:
+ sigmas = self.noise_distribution(batch_size * multiplicity)
+ padded_sigmas = rearrange(sigmas, "b -> b 1 1")
+
+ atom_coords = feats["coords"]
+
+ atom_mask = feats["atom_pad_mask"]
+ atom_mask = atom_mask.repeat_interleave(multiplicity, 0)
+
+ atom_coords = center_random_augmentation(
+ atom_coords, atom_mask, augmentation=self.coordinate_augmentation
+ )
+
+ noise = torch.randn_like(atom_coords)
+ noised_atom_coords = atom_coords + padded_sigmas * noise
+
+ denoised_atom_coords = self.preconditioned_network_forward(
+ noised_atom_coords,
+ sigmas,
+ network_condition_kwargs={
+ "s_inputs": s_inputs,
+ "s_trunk": s_trunk,
+ "feats": feats,
+ "multiplicity": multiplicity,
+ "diffusion_conditioning": diffusion_conditioning,
+ },
+ )
+
+ return {
+ "denoised_atom_coords": denoised_atom_coords,
+ "sigmas": sigmas,
+ "aligned_true_atom_coords": atom_coords,
+ }
+
+ def compute_loss(
+ self,
+ feats,
+ out_dict,
+ add_smooth_lddt_loss=True,
+ nucleotide_loss_weight=5.0,
+ ligand_loss_weight=10.0,
+ multiplicity=1,
+ filter_by_plddt=0.0,
+ ):
+ with torch.autocast("cuda", enabled=False):
+ denoised_atom_coords = out_dict["denoised_atom_coords"].float()
+ sigmas = out_dict["sigmas"].float()
+
+ resolved_atom_mask_uni = feats["atom_resolved_mask"].float()
+
+ if filter_by_plddt > 0:
+ plddt_mask = feats["plddt"] > filter_by_plddt
+ resolved_atom_mask_uni = resolved_atom_mask_uni * plddt_mask.float()
+
+ resolved_atom_mask = resolved_atom_mask_uni.repeat_interleave(
+ multiplicity, 0
+ )
+
+ align_weights = denoised_atom_coords.new_ones(denoised_atom_coords.shape[:2])
+ atom_type = (
+ torch.bmm(
+ feats["atom_to_token"].float(),
+ feats["mol_type"].unsqueeze(-1).float(),
+ )
+ .squeeze(-1)
+ .long()
+ )
+ atom_type_mult = atom_type.repeat_interleave(multiplicity, 0)
+
+ align_weights = (
+ align_weights
+ * (
+ 1
+ + nucleotide_loss_weight
+ * (
+ torch.eq(atom_type_mult, const.chain_type_ids["DNA"]).float()
+ + torch.eq(atom_type_mult, const.chain_type_ids["RNA"]).float()
+ )
+ + ligand_loss_weight
+ * torch.eq(
+ atom_type_mult, const.chain_type_ids["NONPOLYMER"]
+ ).float()
+ ).float()
+ )
+
+ atom_coords = out_dict["aligned_true_atom_coords"].float()
+ atom_coords_aligned_ground_truth = weighted_rigid_align(
+ atom_coords.detach(),
+ denoised_atom_coords.detach(),
+ align_weights.detach(),
+ mask=feats["atom_resolved_mask"]
+ .float()
+ .repeat_interleave(multiplicity, 0)
+ .detach(),
+ )
+
+ # Cast back
+ atom_coords_aligned_ground_truth = atom_coords_aligned_ground_truth.to(
+ denoised_atom_coords
+ )
+
+ # weighted MSE loss of denoised atom positions
+ mse_loss = (
+ (denoised_atom_coords - atom_coords_aligned_ground_truth) ** 2
+ ).sum(dim=-1)
+ mse_loss = torch.sum(
+ mse_loss * align_weights * resolved_atom_mask, dim=-1
+ ) / (torch.sum(3 * align_weights * resolved_atom_mask, dim=-1) + 1e-5)
+
+ # weight by sigma factor
+ loss_weights = self.loss_weight(sigmas)
+ mse_loss = (mse_loss * loss_weights).mean()
+
+ total_loss = mse_loss
+
+ # proposed auxiliary smooth lddt loss
+ lddt_loss = self.zero
+ if add_smooth_lddt_loss:
+ lddt_loss = smooth_lddt_loss(
+ denoised_atom_coords,
+ feats["coords"],
+ torch.eq(atom_type, const.chain_type_ids["DNA"]).float()
+ + torch.eq(atom_type, const.chain_type_ids["RNA"]).float(),
+ coords_mask=resolved_atom_mask_uni,
+ multiplicity=multiplicity,
+ )
+
+ total_loss = total_loss + lddt_loss
+
+ loss_breakdown = {
+ "mse_loss": mse_loss,
+ "smooth_lddt_loss": lddt_loss,
+ }
+
+ return {"loss": total_loss, "loss_breakdown": loss_breakdown}
diff --git a/forks/boltz/src/boltz/model/modules/encoders.py b/forks/boltz/src/boltz/model/modules/encoders.py
new file mode 100644
index 00000000..d5054de9
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/encoders.py
@@ -0,0 +1,639 @@
+# started from code from https://github.com/lucidrains/alphafold3-pytorch, MIT License, Copyright (c) 2024 Phil Wang
+from functools import partial
+from math import pi
+
+import torch
+from einops import rearrange
+from torch import nn
+from torch.nn import Module, ModuleList
+from torch.nn.functional import one_hot
+
+import boltz.model.layers.initialize as init
+from boltz.data import const
+from boltz.model.layers.transition import Transition
+from boltz.model.modules.transformers import AtomTransformer
+from boltz.model.modules.utils import LinearNoBias
+
+
+class FourierEmbedding(Module):
+ """Fourier embedding layer."""
+
+ def __init__(self, dim):
+ """Initialize the Fourier Embeddings.
+
+ Parameters
+ ----------
+ dim : int
+ The dimension of the embeddings.
+
+ """
+ super().__init__()
+ self.proj = nn.Linear(1, dim)
+ torch.nn.init.normal_(self.proj.weight, mean=0, std=1)
+ torch.nn.init.normal_(self.proj.bias, mean=0, std=1)
+ self.proj.requires_grad_(False)
+
+ def forward(
+ self,
+ times,
+ ):
+ times = rearrange(times, "b -> b 1")
+ rand_proj = self.proj(times)
+ return torch.cos(2 * pi * rand_proj)
+
+
+class RelativePositionEncoder(Module):
+ """Relative position encoder."""
+
+ def __init__(self, token_z, r_max=32, s_max=2):
+ """Initialize the relative position encoder.
+
+ Parameters
+ ----------
+ token_z : int
+ The pair representation dimension.
+ r_max : int, optional
+ The maximum index distance, by default 32.
+ s_max : int, optional
+ The maximum chain distance, by default 2.
+
+ """
+ super().__init__()
+ self.r_max = r_max
+ self.s_max = s_max
+ self.linear_layer = LinearNoBias(4 * (r_max + 1) + 2 * (s_max + 1) + 1, token_z)
+
+ def forward(self, feats):
+ b_same_chain = torch.eq(
+ feats["asym_id"][:, :, None], feats["asym_id"][:, None, :]
+ )
+ b_same_residue = torch.eq(
+ feats["residue_index"][:, :, None], feats["residue_index"][:, None, :]
+ )
+ b_same_entity = torch.eq(
+ feats["entity_id"][:, :, None], feats["entity_id"][:, None, :]
+ )
+ rel_pos = (
+ feats["residue_index"][:, :, None] - feats["residue_index"][:, None, :]
+ )
+ if torch.any(feats["cyclic_period"] != 0):
+ period = torch.where(
+ feats["cyclic_period"] > 0,
+ feats["cyclic_period"],
+ torch.zeros_like(feats["cyclic_period"]) + 10000,
+ ).unsqueeze(1)
+ rel_pos = (rel_pos - period * torch.round(rel_pos / period)).long()
+
+ d_residue = torch.clip(
+ rel_pos + self.r_max,
+ 0,
+ 2 * self.r_max,
+ )
+
+ d_residue = torch.where(
+ b_same_chain, d_residue, torch.zeros_like(d_residue) + 2 * self.r_max + 1
+ )
+ a_rel_pos = one_hot(d_residue, 2 * self.r_max + 2)
+
+ d_token = torch.clip(
+ feats["token_index"][:, :, None]
+ - feats["token_index"][:, None, :]
+ + self.r_max,
+ 0,
+ 2 * self.r_max,
+ )
+ d_token = torch.where(
+ b_same_chain & b_same_residue,
+ d_token,
+ torch.zeros_like(d_token) + 2 * self.r_max + 1,
+ )
+ a_rel_token = one_hot(d_token, 2 * self.r_max + 2)
+
+ d_chain = torch.clip(
+ feats["sym_id"][:, :, None] - feats["sym_id"][:, None, :] + self.s_max,
+ 0,
+ 2 * self.s_max,
+ )
+ d_chain = torch.where(
+ b_same_chain, torch.zeros_like(d_chain) + 2 * self.s_max + 1, d_chain
+ )
+ a_rel_chain = one_hot(d_chain, 2 * self.s_max + 2)
+
+ p = self.linear_layer(
+ torch.cat(
+ [
+ a_rel_pos.float(),
+ a_rel_token.float(),
+ b_same_entity.unsqueeze(-1).float(),
+ a_rel_chain.float(),
+ ],
+ dim=-1,
+ )
+ )
+ return p
+
+
+class SingleConditioning(Module):
+ """Single conditioning layer."""
+
+ def __init__(
+ self,
+ sigma_data: float,
+ token_s=384,
+ dim_fourier=256,
+ num_transitions=2,
+ transition_expansion_factor=2,
+ eps=1e-20,
+ ):
+ """Initialize the single conditioning layer.
+
+ Parameters
+ ----------
+ sigma_data : float
+ The data sigma.
+ token_s : int, optional
+ The single representation dimension, by default 384.
+ dim_fourier : int, optional
+ The fourier embeddings dimension, by default 256.
+ num_transitions : int, optional
+ The number of transitions layers, by default 2.
+ transition_expansion_factor : int, optional
+ The transition expansion factor, by default 2.
+ eps : float, optional
+ The epsilon value, by default 1e-20.
+
+ """
+ super().__init__()
+ self.eps = eps
+ self.sigma_data = sigma_data
+
+ input_dim = (
+ 2 * token_s + 2 * const.num_tokens + 1 + len(const.pocket_contact_info)
+ )
+ self.norm_single = nn.LayerNorm(input_dim)
+ self.single_embed = nn.Linear(input_dim, 2 * token_s)
+ self.fourier_embed = FourierEmbedding(dim_fourier)
+ self.norm_fourier = nn.LayerNorm(dim_fourier)
+ self.fourier_to_single = LinearNoBias(dim_fourier, 2 * token_s)
+
+ transitions = ModuleList([])
+ for _ in range(num_transitions):
+ transition = Transition(
+ dim=2 * token_s, hidden=transition_expansion_factor * 2 * token_s
+ )
+ transitions.append(transition)
+
+ self.transitions = transitions
+
+ def forward(
+ self,
+ *,
+ times,
+ s_trunk,
+ s_inputs,
+ ):
+ s = torch.cat((s_trunk, s_inputs), dim=-1)
+ s = self.single_embed(self.norm_single(s))
+ fourier_embed = self.fourier_embed(times)
+ normed_fourier = self.norm_fourier(fourier_embed)
+ fourier_to_single = self.fourier_to_single(normed_fourier)
+
+ s = rearrange(fourier_to_single, "b d -> b 1 d") + s
+
+ for transition in self.transitions:
+ s = transition(s) + s
+
+ return s, normed_fourier
+
+
+class PairwiseConditioning(Module):
+ """Pairwise conditioning layer."""
+
+ def __init__(
+ self,
+ token_z,
+ dim_token_rel_pos_feats,
+ num_transitions=2,
+ transition_expansion_factor=2,
+ ):
+ """Initialize the pairwise conditioning layer.
+
+ Parameters
+ ----------
+ token_z : int
+ The pair representation dimension.
+ dim_token_rel_pos_feats : int
+ The token relative position features dimension.
+ num_transitions : int, optional
+ The number of transitions layers, by default 2.
+ transition_expansion_factor : int, optional
+ The transition expansion factor, by default 2.
+
+ """
+ super().__init__()
+
+ self.dim_pairwise_init_proj = nn.Sequential(
+ nn.LayerNorm(token_z + dim_token_rel_pos_feats),
+ LinearNoBias(token_z + dim_token_rel_pos_feats, token_z),
+ )
+
+ transitions = ModuleList([])
+ for _ in range(num_transitions):
+ transition = Transition(
+ dim=token_z, hidden=transition_expansion_factor * token_z
+ )
+ transitions.append(transition)
+
+ self.transitions = transitions
+
+ def forward(
+ self,
+ z_trunk,
+ token_rel_pos_feats,
+ ):
+ z = torch.cat((z_trunk, token_rel_pos_feats), dim=-1)
+ z = self.dim_pairwise_init_proj(z)
+
+ for transition in self.transitions:
+ z = transition(z) + z
+
+ return z
+
+
+def get_indexing_matrix(K, W, H, device):
+ assert W % 2 == 0
+ assert H % (W // 2) == 0
+
+ h = H // (W // 2)
+ assert h % 2 == 0
+
+ arange = torch.arange(2 * K, device=device)
+ index = ((arange.unsqueeze(0) - arange.unsqueeze(1)) + h // 2).clamp(
+ min=0, max=h + 1
+ )
+ index = index.view(K, 2, 2 * K)[:, 0, :]
+ onehot = one_hot(index, num_classes=h + 2)[..., 1:-1].transpose(1, 0)
+ return onehot.reshape(2 * K, h * K).float()
+
+
+def single_to_keys(single, indexing_matrix, W, H):
+ B, N, D = single.shape
+ K = N // W
+ single = single.view(B, 2 * K, W // 2, D)
+ return torch.einsum("b j i d, j k -> b k i d", single, indexing_matrix).reshape(
+ B, K, H, D
+ )
+
+
+class AtomAttentionEncoder(Module):
+ """Atom attention encoder."""
+
+ def __init__(
+ self,
+ atom_s,
+ atom_z,
+ token_s,
+ token_z,
+ atoms_per_window_queries,
+ atoms_per_window_keys,
+ atom_feature_dim,
+ atom_encoder_depth=3,
+ atom_encoder_heads=4,
+ structure_prediction=True,
+ activation_checkpointing=False,
+ ):
+ """Initialize the atom attention encoder.
+
+ Parameters
+ ----------
+ atom_s : int
+ The atom single representation dimension.
+ atom_z : int
+ The atom pair representation dimension.
+ token_s : int
+ The single representation dimension.
+ token_z : int
+ The pair representation dimension.
+ atoms_per_window_queries : int
+ The number of atoms per window for queries.
+ atoms_per_window_keys : int
+ The number of atoms per window for keys.
+ atom_feature_dim : int
+ The atom feature dimension.
+ atom_encoder_depth : int, optional
+ The number of transformer layers, by default 3.
+ atom_encoder_heads : int, optional
+ The number of transformer heads, by default 4.
+ structure_prediction : bool, optional
+ Whether it is used in the diffusion module, by default True.
+ activation_checkpointing : bool, optional
+ Whether to use activation checkpointing, by default False.
+
+ """
+ super().__init__()
+
+ self.embed_atom_features = LinearNoBias(atom_feature_dim, atom_s)
+ self.embed_atompair_ref_pos = LinearNoBias(3, atom_z)
+ self.embed_atompair_ref_dist = LinearNoBias(1, atom_z)
+ self.embed_atompair_mask = LinearNoBias(1, atom_z)
+ self.atoms_per_window_queries = atoms_per_window_queries
+ self.atoms_per_window_keys = atoms_per_window_keys
+
+ self.structure_prediction = structure_prediction
+ if structure_prediction:
+ self.s_to_c_trans = nn.Sequential(
+ nn.LayerNorm(token_s), LinearNoBias(token_s, atom_s)
+ )
+ init.final_init_(self.s_to_c_trans[1].weight)
+
+ self.z_to_p_trans = nn.Sequential(
+ nn.LayerNorm(token_z), LinearNoBias(token_z, atom_z)
+ )
+ init.final_init_(self.z_to_p_trans[1].weight)
+
+ self.r_to_q_trans = LinearNoBias(10, atom_s)
+ init.final_init_(self.r_to_q_trans.weight)
+
+ self.c_to_p_trans_k = nn.Sequential(
+ nn.ReLU(),
+ LinearNoBias(atom_s, atom_z),
+ )
+ init.final_init_(self.c_to_p_trans_k[1].weight)
+
+ self.c_to_p_trans_q = nn.Sequential(
+ nn.ReLU(),
+ LinearNoBias(atom_s, atom_z),
+ )
+ init.final_init_(self.c_to_p_trans_q[1].weight)
+
+ self.p_mlp = nn.Sequential(
+ nn.ReLU(),
+ LinearNoBias(atom_z, atom_z),
+ nn.ReLU(),
+ LinearNoBias(atom_z, atom_z),
+ nn.ReLU(),
+ LinearNoBias(atom_z, atom_z),
+ )
+ init.final_init_(self.p_mlp[5].weight)
+
+ self.atom_encoder = AtomTransformer(
+ dim=atom_s,
+ dim_single_cond=atom_s,
+ dim_pairwise=atom_z,
+ attn_window_queries=atoms_per_window_queries,
+ attn_window_keys=atoms_per_window_keys,
+ depth=atom_encoder_depth,
+ heads=atom_encoder_heads,
+ activation_checkpointing=activation_checkpointing,
+ )
+
+ self.atom_to_token_trans = nn.Sequential(
+ LinearNoBias(atom_s, 2 * token_s if structure_prediction else token_s),
+ nn.ReLU(),
+ )
+
+ def forward(
+ self,
+ feats,
+ s_trunk=None,
+ z=None,
+ r=None,
+ multiplicity=1,
+ model_cache=None,
+ ):
+ B, N, _ = feats["ref_pos"].shape
+ atom_mask = feats["atom_pad_mask"].bool()
+
+ layer_cache = None
+ if model_cache is not None:
+ cache_prefix = "atomencoder"
+ if cache_prefix not in model_cache:
+ model_cache[cache_prefix] = {}
+ layer_cache = model_cache[cache_prefix]
+
+ if model_cache is None or len(layer_cache) == 0:
+ # either model is not using the cache or it is the first time running it
+
+ atom_ref_pos = feats["ref_pos"]
+ atom_uid = feats["ref_space_uid"]
+ atom_feats = torch.cat(
+ [
+ atom_ref_pos,
+ feats["ref_charge"].unsqueeze(-1),
+ feats["atom_pad_mask"].unsqueeze(-1),
+ feats["ref_element"],
+ feats["ref_atom_name_chars"].reshape(B, N, 4 * 64),
+ ],
+ dim=-1,
+ )
+
+ c = self.embed_atom_features(atom_feats)
+
+ # NOTE: we are already creating the windows to make it more efficient
+ W, H = self.atoms_per_window_queries, self.atoms_per_window_keys
+ B, N = c.shape[:2]
+ K = N // W
+ keys_indexing_matrix = get_indexing_matrix(K, W, H, c.device)
+ to_keys = partial(
+ single_to_keys, indexing_matrix=keys_indexing_matrix, W=W, H=H
+ )
+
+ atom_ref_pos_queries = atom_ref_pos.view(B, K, W, 1, 3)
+ atom_ref_pos_keys = to_keys(atom_ref_pos).view(B, K, 1, H, 3)
+
+ d = atom_ref_pos_keys - atom_ref_pos_queries
+ d_norm = torch.sum(d * d, dim=-1, keepdim=True)
+ d_norm = 1 / (1 + d_norm)
+
+ atom_mask_queries = atom_mask.view(B, K, W, 1)
+ atom_mask_keys = (
+ to_keys(atom_mask.unsqueeze(-1).float()).view(B, K, 1, H).bool()
+ )
+ atom_uid_queries = atom_uid.view(B, K, W, 1)
+ atom_uid_keys = (
+ to_keys(atom_uid.unsqueeze(-1).float()).view(B, K, 1, H).long()
+ )
+ v = (
+ (
+ atom_mask_queries
+ & atom_mask_keys
+ & (atom_uid_queries == atom_uid_keys)
+ )
+ .float()
+ .unsqueeze(-1)
+ )
+
+ p = self.embed_atompair_ref_pos(d) * v
+ p = p + self.embed_atompair_ref_dist(d_norm) * v
+ p = p + self.embed_atompair_mask(v) * v
+
+ q = c
+
+ if self.structure_prediction:
+ # run only in structure model not in initial encoding
+ atom_to_token = feats["atom_to_token"].float()
+
+ s_to_c = self.s_to_c_trans(s_trunk)
+ s_to_c = torch.bmm(atom_to_token, s_to_c)
+ c = c + s_to_c
+
+ atom_to_token_queries = atom_to_token.view(
+ B, K, W, atom_to_token.shape[-1]
+ )
+ atom_to_token_keys = to_keys(atom_to_token)
+ z_to_p = self.z_to_p_trans(z)
+ z_to_p = torch.einsum(
+ "bijd,bwki,bwlj->bwkld",
+ z_to_p,
+ atom_to_token_queries,
+ atom_to_token_keys,
+ )
+ p = p + z_to_p
+
+ p = p + self.c_to_p_trans_q(c.view(B, K, W, 1, c.shape[-1]))
+ p = p + self.c_to_p_trans_k(to_keys(c).view(B, K, 1, H, c.shape[-1]))
+ p = p + self.p_mlp(p)
+
+ if model_cache is not None:
+ layer_cache["q"] = q
+ layer_cache["c"] = c
+ layer_cache["p"] = p
+ layer_cache["to_keys"] = to_keys
+
+ else:
+ q = layer_cache["q"]
+ c = layer_cache["c"]
+ p = layer_cache["p"]
+ to_keys = layer_cache["to_keys"]
+
+ if self.structure_prediction:
+ # only here the multiplicity kicks in because we use the different positions r
+ q = q.repeat_interleave(multiplicity, 0)
+ r_input = torch.cat(
+ [r, torch.zeros((B * multiplicity, N, 7)).to(r)],
+ dim=-1,
+ )
+ r_to_q = self.r_to_q_trans(r_input)
+ q = q + r_to_q
+
+ c = c.repeat_interleave(multiplicity, 0)
+ atom_mask = atom_mask.repeat_interleave(multiplicity, 0)
+
+ q = self.atom_encoder(
+ q=q,
+ mask=atom_mask,
+ c=c,
+ p=p,
+ multiplicity=multiplicity,
+ to_keys=to_keys,
+ model_cache=layer_cache,
+ )
+
+ q_to_a = self.atom_to_token_trans(q)
+ atom_to_token = feats["atom_to_token"].float()
+ atom_to_token = atom_to_token.repeat_interleave(multiplicity, 0)
+ atom_to_token_mean = atom_to_token / (
+ atom_to_token.sum(dim=1, keepdim=True) + 1e-6
+ )
+ a = torch.bmm(atom_to_token_mean.transpose(1, 2), q_to_a)
+
+ return a, q, c, p, to_keys
+
+
+class AtomAttentionDecoder(Module):
+ """Atom attention decoder."""
+
+ def __init__(
+ self,
+ atom_s,
+ atom_z,
+ token_s,
+ attn_window_queries,
+ attn_window_keys,
+ atom_decoder_depth=3,
+ atom_decoder_heads=4,
+ activation_checkpointing=False,
+ ):
+ """Initialize the atom attention decoder.
+
+ Parameters
+ ----------
+ atom_s : int
+ The atom single representation dimension.
+ atom_z : int
+ The atom pair representation dimension.
+ token_s : int
+ The single representation dimension.
+ attn_window_queries : int
+ The number of atoms per window for queries.
+ attn_window_keys : int
+ The number of atoms per window for keys.
+ atom_decoder_depth : int, optional
+ The number of transformer layers, by default 3.
+ atom_decoder_heads : int, optional
+ The number of transformer heads, by default 4.
+ activation_checkpointing : bool, optional
+ Whether to use activation checkpointing, by default False.
+
+ """
+ super().__init__()
+
+ self.a_to_q_trans = LinearNoBias(2 * token_s, atom_s)
+ init.final_init_(self.a_to_q_trans.weight)
+
+ self.atom_decoder = AtomTransformer(
+ dim=atom_s,
+ dim_single_cond=atom_s,
+ dim_pairwise=atom_z,
+ attn_window_queries=attn_window_queries,
+ attn_window_keys=attn_window_keys,
+ depth=atom_decoder_depth,
+ heads=atom_decoder_heads,
+ activation_checkpointing=activation_checkpointing,
+ )
+
+ self.atom_feat_to_atom_pos_update = nn.Sequential(
+ nn.LayerNorm(atom_s), LinearNoBias(atom_s, 3)
+ )
+ init.final_init_(self.atom_feat_to_atom_pos_update[1].weight)
+
+ def forward(
+ self,
+ a,
+ q,
+ c,
+ p,
+ feats,
+ to_keys,
+ multiplicity=1,
+ model_cache=None,
+ ):
+ atom_mask = feats["atom_pad_mask"]
+ atom_mask = atom_mask.repeat_interleave(multiplicity, 0)
+
+ atom_to_token = feats["atom_to_token"].float()
+ atom_to_token = atom_to_token.repeat_interleave(multiplicity, 0)
+
+ a_to_q = self.a_to_q_trans(a)
+ a_to_q = torch.bmm(atom_to_token, a_to_q)
+ q = q + a_to_q
+
+ layer_cache = None
+ if model_cache is not None:
+ cache_prefix = "atomdecoder"
+ if cache_prefix not in model_cache:
+ model_cache[cache_prefix] = {}
+ layer_cache = model_cache[cache_prefix]
+
+ q = self.atom_decoder(
+ q=q,
+ mask=atom_mask,
+ c=c,
+ p=p,
+ multiplicity=multiplicity,
+ to_keys=to_keys,
+ model_cache=layer_cache,
+ )
+
+ r_update = self.atom_feat_to_atom_pos_update(q)
+ return r_update
diff --git a/forks/boltz/src/boltz/model/modules/encodersv2.py b/forks/boltz/src/boltz/model/modules/encodersv2.py
new file mode 100644
index 00000000..f02cc3ec
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/encodersv2.py
@@ -0,0 +1,565 @@
+# started from code from https://github.com/lucidrains/alphafold3-pytorch, MIT License, Copyright (c) 2024 Phil Wang
+from functools import partial
+from math import pi
+
+import torch
+from einops import rearrange
+from torch import nn
+from torch.nn import Linear, Module, ModuleList
+from torch.nn.functional import one_hot
+
+import boltz.model.layers.initialize as init
+from boltz.model.layers.transition import Transition
+from boltz.model.modules.transformersv2 import AtomTransformer
+from boltz.model.modules.utils import LinearNoBias
+
+
+class FourierEmbedding(Module):
+ """Algorithm 22."""
+
+ def __init__(self, dim):
+ super().__init__()
+ self.proj = nn.Linear(1, dim)
+ torch.nn.init.normal_(self.proj.weight, mean=0, std=1)
+ torch.nn.init.normal_(self.proj.bias, mean=0, std=1)
+ self.proj.requires_grad_(False)
+
+ def forward(
+ self,
+ times, # Float[' b'],
+ ): # -> Float['b d']:
+ times = rearrange(times, "b -> b 1")
+ rand_proj = self.proj(times)
+ return torch.cos(2 * pi * rand_proj)
+
+
+class RelativePositionEncoder(Module):
+ """Algorithm 3."""
+
+ def __init__(
+ self, token_z, r_max=32, s_max=2, fix_sym_check=False, cyclic_pos_enc=False
+ ):
+ super().__init__()
+ self.r_max = r_max
+ self.s_max = s_max
+ self.linear_layer = LinearNoBias(4 * (r_max + 1) + 2 * (s_max + 1) + 1, token_z)
+ self.fix_sym_check = fix_sym_check
+ self.cyclic_pos_enc = cyclic_pos_enc
+
+ def forward(self, feats):
+ b_same_chain = torch.eq(
+ feats["asym_id"][:, :, None], feats["asym_id"][:, None, :]
+ )
+ b_same_residue = torch.eq(
+ feats["residue_index"][:, :, None], feats["residue_index"][:, None, :]
+ )
+ b_same_entity = torch.eq(
+ feats["entity_id"][:, :, None], feats["entity_id"][:, None, :]
+ )
+
+ d_residue = (
+ feats["residue_index"][:, :, None] - feats["residue_index"][:, None, :]
+ )
+
+ if self.cyclic_pos_enc and torch.any(feats["cyclic_period"] > 0):
+ period = torch.where(
+ feats["cyclic_period"] > 0,
+ feats["cyclic_period"],
+ torch.zeros_like(feats["cyclic_period"]) + 10000,
+ )
+ d_residue = (d_residue - period * torch.round(d_residue / period)).long()
+
+ d_residue = torch.clip(
+ d_residue + self.r_max,
+ 0,
+ 2 * self.r_max,
+ )
+ d_residue = torch.where(
+ b_same_chain, d_residue, torch.zeros_like(d_residue) + 2 * self.r_max + 1
+ )
+ a_rel_pos = one_hot(d_residue, 2 * self.r_max + 2)
+
+ d_token = torch.clip(
+ feats["token_index"][:, :, None]
+ - feats["token_index"][:, None, :]
+ + self.r_max,
+ 0,
+ 2 * self.r_max,
+ )
+ d_token = torch.where(
+ b_same_chain & b_same_residue,
+ d_token,
+ torch.zeros_like(d_token) + 2 * self.r_max + 1,
+ )
+ a_rel_token = one_hot(d_token, 2 * self.r_max + 2)
+
+ d_chain = torch.clip(
+ feats["sym_id"][:, :, None] - feats["sym_id"][:, None, :] + self.s_max,
+ 0,
+ 2 * self.s_max,
+ )
+ d_chain = torch.where(
+ (~b_same_entity) if self.fix_sym_check else b_same_chain,
+ torch.zeros_like(d_chain) + 2 * self.s_max + 1,
+ d_chain,
+ )
+ # Note: added | (~b_same_entity) based on observation of ProteinX manuscript
+ a_rel_chain = one_hot(d_chain, 2 * self.s_max + 2)
+
+ p = self.linear_layer(
+ torch.cat(
+ [
+ a_rel_pos.float(),
+ a_rel_token.float(),
+ b_same_entity.unsqueeze(-1).float(),
+ a_rel_chain.float(),
+ ],
+ dim=-1,
+ )
+ )
+ return p
+
+
+class SingleConditioning(Module):
+ """Algorithm 21."""
+
+ def __init__(
+ self,
+ sigma_data: float,
+ token_s: int = 384,
+ dim_fourier: int = 256,
+ num_transitions: int = 2,
+ transition_expansion_factor: int = 2,
+ eps: float = 1e-20,
+ disable_times: bool = False,
+ ) -> None:
+ super().__init__()
+ self.eps = eps
+ self.sigma_data = sigma_data
+ self.disable_times = disable_times
+
+ self.norm_single = nn.LayerNorm(2 * token_s)
+ self.single_embed = nn.Linear(2 * token_s, 2 * token_s)
+ if not self.disable_times:
+ self.fourier_embed = FourierEmbedding(dim_fourier)
+ self.norm_fourier = nn.LayerNorm(dim_fourier)
+ self.fourier_to_single = LinearNoBias(dim_fourier, 2 * token_s)
+
+ transitions = ModuleList([])
+ for _ in range(num_transitions):
+ transition = Transition(
+ dim=2 * token_s, hidden=transition_expansion_factor * 2 * token_s
+ )
+ transitions.append(transition)
+
+ self.transitions = transitions
+
+ def forward(
+ self,
+ times, # Float[' b'],
+ s_trunk, # Float['b n ts'],
+ s_inputs, # Float['b n ts'],
+ ): # -> Float['b n 2ts']:
+ s = torch.cat((s_trunk, s_inputs), dim=-1)
+ s = self.single_embed(self.norm_single(s))
+ if not self.disable_times:
+ fourier_embed = self.fourier_embed(
+ times
+ ) # note: sigma rescaling done in diffusion module
+ normed_fourier = self.norm_fourier(fourier_embed)
+ fourier_to_single = self.fourier_to_single(normed_fourier)
+
+ s = rearrange(fourier_to_single, "b d -> b 1 d") + s
+
+ for transition in self.transitions:
+ s = transition(s) + s
+
+ return s, normed_fourier if not self.disable_times else None
+
+
+class PairwiseConditioning(Module):
+ """Algorithm 21."""
+
+ def __init__(
+ self,
+ token_z,
+ dim_token_rel_pos_feats,
+ num_transitions=2,
+ transition_expansion_factor=2,
+ ):
+ super().__init__()
+
+ self.dim_pairwise_init_proj = nn.Sequential(
+ nn.LayerNorm(token_z + dim_token_rel_pos_feats),
+ LinearNoBias(token_z + dim_token_rel_pos_feats, token_z),
+ )
+
+ transitions = ModuleList([])
+ for _ in range(num_transitions):
+ transition = Transition(
+ dim=token_z, hidden=transition_expansion_factor * token_z
+ )
+ transitions.append(transition)
+
+ self.transitions = transitions
+
+ def forward(
+ self,
+ z_trunk, # Float['b n n tz'],
+ token_rel_pos_feats, # Float['b n n 3'],
+ ): # -> Float['b n n tz']:
+ z = torch.cat((z_trunk, token_rel_pos_feats), dim=-1)
+ z = self.dim_pairwise_init_proj(z)
+
+ for transition in self.transitions:
+ z = transition(z) + z
+
+ return z
+
+
+def get_indexing_matrix(K, W, H, device):
+ assert W % 2 == 0
+ assert H % (W // 2) == 0
+
+ h = H // (W // 2)
+ assert h % 2 == 0
+
+ arange = torch.arange(2 * K, device=device)
+ index = ((arange.unsqueeze(0) - arange.unsqueeze(1)) + h // 2).clamp(
+ min=0, max=h + 1
+ )
+ index = index.view(K, 2, 2 * K)[:, 0, :]
+ onehot = one_hot(index, num_classes=h + 2)[..., 1:-1].transpose(1, 0)
+ return onehot.reshape(2 * K, h * K).float()
+
+
+def single_to_keys(single, indexing_matrix, W, H):
+ B, N, D = single.shape
+ K = N // W
+ single = single.view(B, 2 * K, W // 2, D)
+ return torch.einsum("b j i d, j k -> b k i d", single, indexing_matrix).reshape(
+ B, K, H, D
+ ) # j = 2K, i = W//2, k = h * K
+
+
+class AtomEncoder(Module):
+ def __init__(
+ self,
+ atom_s,
+ atom_z,
+ token_s,
+ token_z,
+ atoms_per_window_queries,
+ atoms_per_window_keys,
+ atom_feature_dim,
+ structure_prediction=True,
+ use_no_atom_char=False,
+ use_atom_backbone_feat=False,
+ use_residue_feats_atoms=False,
+ ):
+ super().__init__()
+
+ self.embed_atom_features = Linear(atom_feature_dim, atom_s)
+ self.embed_atompair_ref_pos = LinearNoBias(3, atom_z)
+ self.embed_atompair_ref_dist = LinearNoBias(1, atom_z)
+ self.embed_atompair_mask = LinearNoBias(1, atom_z)
+ self.atoms_per_window_queries = atoms_per_window_queries
+ self.atoms_per_window_keys = atoms_per_window_keys
+ self.use_no_atom_char = use_no_atom_char
+ self.use_atom_backbone_feat = use_atom_backbone_feat
+ self.use_residue_feats_atoms = use_residue_feats_atoms
+
+ self.structure_prediction = structure_prediction
+ if structure_prediction:
+ self.s_to_c_trans = nn.Sequential(
+ nn.LayerNorm(token_s), LinearNoBias(token_s, atom_s)
+ )
+ init.final_init_(self.s_to_c_trans[1].weight)
+
+ self.z_to_p_trans = nn.Sequential(
+ nn.LayerNorm(token_z), LinearNoBias(token_z, atom_z)
+ )
+ init.final_init_(self.z_to_p_trans[1].weight)
+
+ self.c_to_p_trans_k = nn.Sequential(
+ nn.ReLU(),
+ LinearNoBias(atom_s, atom_z),
+ )
+ init.final_init_(self.c_to_p_trans_k[1].weight)
+
+ self.c_to_p_trans_q = nn.Sequential(
+ nn.ReLU(),
+ LinearNoBias(atom_s, atom_z),
+ )
+ init.final_init_(self.c_to_p_trans_q[1].weight)
+
+ self.p_mlp = nn.Sequential(
+ nn.ReLU(),
+ LinearNoBias(atom_z, atom_z),
+ nn.ReLU(),
+ LinearNoBias(atom_z, atom_z),
+ nn.ReLU(),
+ LinearNoBias(atom_z, atom_z),
+ )
+ init.final_init_(self.p_mlp[5].weight)
+
+ def forward(
+ self,
+ feats,
+ s_trunk=None, # Float['bm n ts'],
+ z=None, # Float['bm n n tz'],
+ ):
+ with torch.autocast("cuda", enabled=False):
+ B, N, _ = feats["ref_pos"].shape
+ atom_mask = feats["atom_pad_mask"].bool() # Bool['b m'],
+
+ atom_ref_pos = feats["ref_pos"] # Float['b m 3'],
+ atom_uid = feats["ref_space_uid"] # Long['b m'],
+
+ atom_feats = [
+ atom_ref_pos,
+ feats["ref_charge"].unsqueeze(-1),
+ feats["ref_element"],
+ ]
+ if not self.use_no_atom_char:
+ atom_feats.append(feats["ref_atom_name_chars"].reshape(B, N, 4 * 64))
+ if self.use_atom_backbone_feat:
+ atom_feats.append(feats["atom_backbone_feat"])
+ if self.use_residue_feats_atoms:
+ res_feats = torch.cat(
+ [
+ feats["res_type"],
+ feats["modified"].unsqueeze(-1),
+ one_hot(feats["mol_type"], num_classes=4).float(),
+ ],
+ dim=-1,
+ )
+ atom_to_token = feats["atom_to_token"].float()
+ atom_res_feats = torch.bmm(atom_to_token, res_feats)
+ atom_feats.append(atom_res_feats)
+
+ atom_feats = torch.cat(atom_feats, dim=-1)
+
+ c = self.embed_atom_features(atom_feats)
+
+ # note we are already creating the windows to make it more efficient
+ W, H = self.atoms_per_window_queries, self.atoms_per_window_keys
+ B, N = c.shape[:2]
+ K = N // W
+ keys_indexing_matrix = get_indexing_matrix(K, W, H, c.device)
+ to_keys = partial(
+ single_to_keys, indexing_matrix=keys_indexing_matrix, W=W, H=H
+ )
+
+ atom_ref_pos_queries = atom_ref_pos.view(B, K, W, 1, 3)
+ atom_ref_pos_keys = to_keys(atom_ref_pos).view(B, K, 1, H, 3)
+
+ d = atom_ref_pos_keys - atom_ref_pos_queries # Float['b k w h 3']
+ d_norm = torch.sum(d * d, dim=-1, keepdim=True) # Float['b k w h 1']
+ d_norm = 1 / (
+ 1 + d_norm
+ ) # AF3 feeds in the reciprocal of the distance norm
+
+ atom_mask_queries = atom_mask.view(B, K, W, 1)
+ atom_mask_keys = (
+ to_keys(atom_mask.unsqueeze(-1).float()).view(B, K, 1, H).bool()
+ )
+ atom_uid_queries = atom_uid.view(B, K, W, 1)
+ atom_uid_keys = (
+ to_keys(atom_uid.unsqueeze(-1).float()).view(B, K, 1, H).long()
+ )
+ v = (
+ (
+ atom_mask_queries
+ & atom_mask_keys
+ & (atom_uid_queries == atom_uid_keys)
+ )
+ .float()
+ .unsqueeze(-1)
+ ) # Bool['b k w h 1']
+
+ p = self.embed_atompair_ref_pos(d) * v
+ p = p + self.embed_atompair_ref_dist(d_norm) * v
+ p = p + self.embed_atompair_mask(v) * v
+
+ q = c
+
+ if self.structure_prediction:
+ # run only in structure model not in initial encoding
+ atom_to_token = feats["atom_to_token"].float() # Long['b m n'],
+
+ s_to_c = self.s_to_c_trans(s_trunk.float())
+ s_to_c = torch.bmm(atom_to_token, s_to_c)
+ c = c + s_to_c.to(c)
+
+ atom_to_token_queries = atom_to_token.view(
+ B, K, W, atom_to_token.shape[-1]
+ )
+ atom_to_token_keys = to_keys(atom_to_token)
+ z_to_p = self.z_to_p_trans(z.float())
+ z_to_p = torch.einsum(
+ "bijd,bwki,bwlj->bwkld",
+ z_to_p,
+ atom_to_token_queries,
+ atom_to_token_keys,
+ )
+ p = p + z_to_p.to(p)
+
+ p = p + self.c_to_p_trans_q(c.view(B, K, W, 1, c.shape[-1]))
+ p = p + self.c_to_p_trans_k(to_keys(c).view(B, K, 1, H, c.shape[-1]))
+ p = p + self.p_mlp(p)
+ return q, c, p, to_keys
+
+
+class AtomAttentionEncoder(Module):
+ def __init__(
+ self,
+ atom_s,
+ token_s,
+ atoms_per_window_queries,
+ atoms_per_window_keys,
+ atom_encoder_depth=3,
+ atom_encoder_heads=4,
+ structure_prediction=True,
+ activation_checkpointing=False,
+ transformer_post_layer_norm=False,
+ ):
+ super().__init__()
+
+ self.structure_prediction = structure_prediction
+ if structure_prediction:
+ self.r_to_q_trans = LinearNoBias(3, atom_s)
+ init.final_init_(self.r_to_q_trans.weight)
+
+ self.atom_encoder = AtomTransformer(
+ dim=atom_s,
+ dim_single_cond=atom_s,
+ attn_window_queries=atoms_per_window_queries,
+ attn_window_keys=atoms_per_window_keys,
+ depth=atom_encoder_depth,
+ heads=atom_encoder_heads,
+ activation_checkpointing=activation_checkpointing,
+ post_layer_norm=transformer_post_layer_norm,
+ )
+
+ self.atom_to_token_trans = nn.Sequential(
+ LinearNoBias(atom_s, 2 * token_s if structure_prediction else token_s),
+ nn.ReLU(),
+ )
+
+ def forward(
+ self,
+ feats,
+ q,
+ c,
+ atom_enc_bias,
+ to_keys,
+ r=None, # Float['bm m 3'],
+ multiplicity=1,
+ ):
+ B, N, _ = feats["ref_pos"].shape
+ atom_mask = feats["atom_pad_mask"].bool() # Bool['b m'],
+
+ if self.structure_prediction:
+ # only here the multiplicity kicks in because we use the different positions r
+ q = q.repeat_interleave(multiplicity, 0)
+ r_to_q = self.r_to_q_trans(r)
+ q = q + r_to_q
+
+ c = c.repeat_interleave(multiplicity, 0)
+ atom_mask = atom_mask.repeat_interleave(multiplicity, 0)
+
+ q = self.atom_encoder(
+ q=q,
+ mask=atom_mask,
+ c=c,
+ bias=atom_enc_bias,
+ multiplicity=multiplicity,
+ to_keys=to_keys,
+ )
+
+ with torch.autocast("cuda", enabled=False):
+ q_to_a = self.atom_to_token_trans(q).float()
+ atom_to_token = feats["atom_to_token"].float()
+ atom_to_token = atom_to_token.repeat_interleave(multiplicity, 0)
+ atom_to_token_mean = atom_to_token / (
+ atom_to_token.sum(dim=1, keepdim=True) + 1e-6
+ )
+ a = torch.bmm(atom_to_token_mean.transpose(1, 2), q_to_a)
+
+ a = a.to(q)
+
+ return a, q, c, to_keys
+
+
+class AtomAttentionDecoder(Module):
+ """Algorithm 6."""
+
+ def __init__(
+ self,
+ atom_s,
+ token_s,
+ attn_window_queries,
+ attn_window_keys,
+ atom_decoder_depth=3,
+ atom_decoder_heads=4,
+ activation_checkpointing=False,
+ transformer_post_layer_norm=False,
+ ):
+ super().__init__()
+
+ self.a_to_q_trans = LinearNoBias(2 * token_s, atom_s)
+ init.final_init_(self.a_to_q_trans.weight)
+
+ self.atom_decoder = AtomTransformer(
+ dim=atom_s,
+ dim_single_cond=atom_s,
+ attn_window_queries=attn_window_queries,
+ attn_window_keys=attn_window_keys,
+ depth=atom_decoder_depth,
+ heads=atom_decoder_heads,
+ activation_checkpointing=activation_checkpointing,
+ post_layer_norm=transformer_post_layer_norm,
+ )
+
+ if transformer_post_layer_norm:
+ self.atom_feat_to_atom_pos_update = LinearNoBias(atom_s, 3)
+ init.final_init_(self.atom_feat_to_atom_pos_update.weight)
+ else:
+ self.atom_feat_to_atom_pos_update = nn.Sequential(
+ nn.LayerNorm(atom_s), LinearNoBias(atom_s, 3)
+ )
+ init.final_init_(self.atom_feat_to_atom_pos_update[1].weight)
+
+ def forward(
+ self,
+ a, # Float['bm n 2ts'],
+ q, # Float['bm m as'],
+ c, # Float['bm m as'],
+ atom_dec_bias, # Float['bm m m az'],
+ feats,
+ to_keys,
+ multiplicity=1,
+ ):
+ with torch.autocast("cuda", enabled=False):
+ atom_to_token = feats["atom_to_token"].float()
+ atom_to_token = atom_to_token.repeat_interleave(multiplicity, 0)
+
+ a_to_q = self.a_to_q_trans(a.float())
+ a_to_q = torch.bmm(atom_to_token, a_to_q)
+
+ q = q + a_to_q.to(q)
+ atom_mask = feats["atom_pad_mask"] # Bool['b m'],
+ atom_mask = atom_mask.repeat_interleave(multiplicity, 0)
+
+ q = self.atom_decoder(
+ q=q,
+ mask=atom_mask,
+ c=c,
+ bias=atom_dec_bias,
+ multiplicity=multiplicity,
+ to_keys=to_keys,
+ )
+
+ r_update = self.atom_feat_to_atom_pos_update(q)
+ return r_update
diff --git a/forks/boltz/src/boltz/model/modules/transformers.py b/forks/boltz/src/boltz/model/modules/transformers.py
new file mode 100644
index 00000000..b1e1fbae
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/transformers.py
@@ -0,0 +1,322 @@
+# started from code from https://github.com/lucidrains/alphafold3-pytorch, MIT License, Copyright (c) 2024 Phil Wang
+
+from fairscale.nn.checkpoint.checkpoint_activations import checkpoint_wrapper
+from torch import nn, sigmoid
+from torch.nn import (
+ LayerNorm,
+ Linear,
+ Module,
+ ModuleList,
+ Sequential,
+)
+
+from boltz.model.layers.attention import AttentionPairBias
+from boltz.model.modules.utils import LinearNoBias, SwiGLU, default
+
+
+class AdaLN(Module):
+ """Adaptive Layer Normalization"""
+
+ def __init__(self, dim, dim_single_cond):
+ """Initialize the adaptive layer normalization.
+
+ Parameters
+ ----------
+ dim : int
+ The input dimension.
+ dim_single_cond : int
+ The single condition dimension.
+
+ """
+ super().__init__()
+ self.a_norm = LayerNorm(dim, elementwise_affine=False, bias=False)
+ self.s_norm = LayerNorm(dim_single_cond, bias=False)
+ self.s_scale = Linear(dim_single_cond, dim)
+ self.s_bias = LinearNoBias(dim_single_cond, dim)
+
+ def forward(self, a, s):
+ a = self.a_norm(a)
+ s = self.s_norm(s)
+ a = sigmoid(self.s_scale(s)) * a + self.s_bias(s)
+ return a
+
+
+class ConditionedTransitionBlock(Module):
+ """Conditioned Transition Block"""
+
+ def __init__(self, dim_single, dim_single_cond, expansion_factor=2):
+ """Initialize the conditioned transition block.
+
+ Parameters
+ ----------
+ dim_single : int
+ The single dimension.
+ dim_single_cond : int
+ The single condition dimension.
+ expansion_factor : int, optional
+ The expansion factor, by default 2
+
+ """
+ super().__init__()
+
+ self.adaln = AdaLN(dim_single, dim_single_cond)
+
+ dim_inner = int(dim_single * expansion_factor)
+ self.swish_gate = Sequential(
+ LinearNoBias(dim_single, dim_inner * 2),
+ SwiGLU(),
+ )
+ self.a_to_b = LinearNoBias(dim_single, dim_inner)
+ self.b_to_a = LinearNoBias(dim_inner, dim_single)
+
+ output_projection_linear = Linear(dim_single_cond, dim_single)
+ nn.init.zeros_(output_projection_linear.weight)
+ nn.init.constant_(output_projection_linear.bias, -2.0)
+
+ self.output_projection = nn.Sequential(output_projection_linear, nn.Sigmoid())
+
+ def forward(
+ self,
+ a,
+ s,
+ ):
+ a = self.adaln(a, s)
+ b = self.swish_gate(a) * self.a_to_b(a)
+ a = self.output_projection(s) * self.b_to_a(b)
+
+ return a
+
+
+class DiffusionTransformer(Module):
+ """Diffusion Transformer"""
+
+ def __init__(
+ self,
+ depth,
+ heads,
+ dim=384,
+ dim_single_cond=None,
+ dim_pairwise=128,
+ activation_checkpointing=False,
+ offload_to_cpu=False,
+ ):
+ """Initialize the diffusion transformer.
+
+ Parameters
+ ----------
+ depth : int
+ The depth.
+ heads : int
+ The number of heads.
+ dim : int, optional
+ The dimension, by default 384
+ dim_single_cond : int, optional
+ The single condition dimension, by default None
+ dim_pairwise : int, optional
+ The pairwise dimension, by default 128
+ activation_checkpointing : bool, optional
+ Whether to use activation checkpointing, by default False
+ offload_to_cpu : bool, optional
+ Whether to offload to CPU, by default False
+
+ """
+ super().__init__()
+ self.activation_checkpointing = activation_checkpointing
+ dim_single_cond = default(dim_single_cond, dim)
+
+ self.layers = ModuleList()
+ for _ in range(depth):
+ if activation_checkpointing:
+ self.layers.append(
+ checkpoint_wrapper(
+ DiffusionTransformerLayer(
+ heads,
+ dim,
+ dim_single_cond,
+ dim_pairwise,
+ ),
+ offload_to_cpu=offload_to_cpu,
+ )
+ )
+ else:
+ self.layers.append(
+ DiffusionTransformerLayer(
+ heads,
+ dim,
+ dim_single_cond,
+ dim_pairwise,
+ )
+ )
+
+ def forward(
+ self,
+ a,
+ s,
+ z,
+ mask=None,
+ to_keys=None,
+ multiplicity=1,
+ model_cache=None,
+ ):
+ for i, layer in enumerate(self.layers):
+ layer_cache = None
+ if model_cache is not None:
+ prefix_cache = "layer_" + str(i)
+ if prefix_cache not in model_cache:
+ model_cache[prefix_cache] = {}
+ layer_cache = model_cache[prefix_cache]
+ a = layer(
+ a,
+ s,
+ z,
+ mask=mask,
+ to_keys=to_keys,
+ multiplicity=multiplicity,
+ layer_cache=layer_cache,
+ )
+ return a
+
+
+class DiffusionTransformerLayer(Module):
+ """Diffusion Transformer Layer"""
+
+ def __init__(
+ self,
+ heads,
+ dim=384,
+ dim_single_cond=None,
+ dim_pairwise=128,
+ ):
+ """Initialize the diffusion transformer layer.
+
+ Parameters
+ ----------
+ heads : int
+ The number of heads.
+ dim : int, optional
+ The dimension, by default 384
+ dim_single_cond : int, optional
+ The single condition dimension, by default None
+ dim_pairwise : int, optional
+ The pairwise dimension, by default 128
+
+ """
+ super().__init__()
+
+ dim_single_cond = default(dim_single_cond, dim)
+
+ self.adaln = AdaLN(dim, dim_single_cond)
+
+ self.pair_bias_attn = AttentionPairBias(
+ c_s=dim, c_z=dim_pairwise, num_heads=heads, initial_norm=False
+ )
+
+ self.output_projection_linear = Linear(dim_single_cond, dim)
+ nn.init.zeros_(self.output_projection_linear.weight)
+ nn.init.constant_(self.output_projection_linear.bias, -2.0)
+
+ self.output_projection = nn.Sequential(
+ self.output_projection_linear, nn.Sigmoid()
+ )
+ self.transition = ConditionedTransitionBlock(
+ dim_single=dim, dim_single_cond=dim_single_cond
+ )
+
+ def forward(
+ self,
+ a,
+ s,
+ z,
+ mask=None,
+ to_keys=None,
+ multiplicity=1,
+ layer_cache=None,
+ ):
+ b = self.adaln(a, s)
+ b = self.pair_bias_attn(
+ s=b,
+ z=z,
+ mask=mask,
+ multiplicity=multiplicity,
+ to_keys=to_keys,
+ model_cache=layer_cache,
+ )
+ b = self.output_projection(s) * b
+
+ # NOTE: Added residual connection!
+ a = a + b
+ a = a + self.transition(a, s)
+ return a
+
+
+class AtomTransformer(Module):
+ """Atom Transformer"""
+
+ def __init__(
+ self,
+ attn_window_queries=None,
+ attn_window_keys=None,
+ **diffusion_transformer_kwargs,
+ ):
+ """Initialize the atom transformer.
+
+ Parameters
+ ----------
+ attn_window_queries : int, optional
+ The attention window queries, by default None
+ attn_window_keys : int, optional
+ The attention window keys, by default None
+ diffusion_transformer_kwargs : dict
+ The diffusion transformer keyword arguments
+
+ """
+ super().__init__()
+ self.attn_window_queries = attn_window_queries
+ self.attn_window_keys = attn_window_keys
+ self.diffusion_transformer = DiffusionTransformer(
+ **diffusion_transformer_kwargs
+ )
+
+ def forward(
+ self,
+ q,
+ c,
+ p,
+ to_keys=None,
+ mask=None,
+ multiplicity=1,
+ model_cache=None,
+ ):
+ W = self.attn_window_queries
+ H = self.attn_window_keys
+
+ if W is not None:
+ B, N, D = q.shape
+ NW = N // W
+
+ # reshape tokens
+ q = q.view((B * NW, W, -1))
+ c = c.view((B * NW, W, -1))
+ if mask is not None:
+ mask = mask.view(B * NW, W)
+ p = p.view((p.shape[0] * NW, W, H, -1))
+
+ to_keys_new = lambda x: to_keys(x.view(B, NW * W, -1)).view(B * NW, H, -1)
+ else:
+ to_keys_new = None
+
+ # main transformer
+ q = self.diffusion_transformer(
+ a=q,
+ s=c,
+ z=p,
+ mask=mask.float(),
+ multiplicity=multiplicity,
+ to_keys=to_keys_new,
+ model_cache=model_cache,
+ )
+
+ if W is not None:
+ q = q.view((B, NW * W, D))
+
+ return q
diff --git a/forks/boltz/src/boltz/model/modules/transformersv2.py b/forks/boltz/src/boltz/model/modules/transformersv2.py
new file mode 100644
index 00000000..5f76ddac
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/transformersv2.py
@@ -0,0 +1,261 @@
+# started from code from https://github.com/lucidrains/alphafold3-pytorch, MIT License, Copyright (c) 2024 Phil Wang
+
+import torch
+from torch import nn, sigmoid
+from torch.nn import (
+ LayerNorm,
+ Linear,
+ Module,
+ ModuleList,
+ Sequential,
+)
+
+from boltz.model.layers.attentionv2 import AttentionPairBias
+from boltz.model.modules.utils import LinearNoBias, SwiGLU, default
+
+
+class AdaLN(Module):
+ """Algorithm 26"""
+
+ def __init__(self, dim, dim_single_cond):
+ super().__init__()
+ self.a_norm = LayerNorm(dim, elementwise_affine=False, bias=False)
+ self.s_norm = LayerNorm(dim_single_cond, bias=False)
+ self.s_scale = Linear(dim_single_cond, dim)
+ self.s_bias = LinearNoBias(dim_single_cond, dim)
+
+ def forward(self, a, s):
+ a = self.a_norm(a)
+ s = self.s_norm(s)
+ a = sigmoid(self.s_scale(s)) * a + self.s_bias(s)
+ return a
+
+
+class ConditionedTransitionBlock(Module):
+ """Algorithm 25"""
+
+ def __init__(self, dim_single, dim_single_cond, expansion_factor=2):
+ super().__init__()
+
+ self.adaln = AdaLN(dim_single, dim_single_cond)
+
+ dim_inner = int(dim_single * expansion_factor)
+ self.swish_gate = Sequential(
+ LinearNoBias(dim_single, dim_inner * 2),
+ SwiGLU(),
+ )
+ self.a_to_b = LinearNoBias(dim_single, dim_inner)
+ self.b_to_a = LinearNoBias(dim_inner, dim_single)
+
+ output_projection_linear = Linear(dim_single_cond, dim_single)
+ nn.init.zeros_(output_projection_linear.weight)
+ nn.init.constant_(output_projection_linear.bias, -2.0)
+
+ self.output_projection = nn.Sequential(output_projection_linear, nn.Sigmoid())
+
+ def forward(
+ self,
+ a, # Float['... d']
+ s,
+ ): # -> Float['... d']:
+ a = self.adaln(a, s)
+ b = self.swish_gate(a) * self.a_to_b(a)
+ a = self.output_projection(s) * self.b_to_a(b)
+
+ return a
+
+
+class DiffusionTransformer(Module):
+ """Algorithm 23"""
+
+ def __init__(
+ self,
+ depth,
+ heads,
+ dim=384,
+ dim_single_cond=None,
+ pair_bias_attn=True,
+ activation_checkpointing=False,
+ post_layer_norm=False,
+ ):
+ super().__init__()
+ self.activation_checkpointing = activation_checkpointing
+ dim_single_cond = default(dim_single_cond, dim)
+ self.pair_bias_attn = pair_bias_attn
+
+ self.layers = ModuleList()
+ for _ in range(depth):
+ self.layers.append(
+ DiffusionTransformerLayer(
+ heads,
+ dim,
+ dim_single_cond,
+ post_layer_norm,
+ )
+ )
+
+ def forward(
+ self,
+ a, # Float['bm n d'],
+ s, # Float['bm n ds'],
+ bias=None, # Float['b n n dp']
+ mask=None, # Bool['b n'] | None = None
+ to_keys=None,
+ multiplicity=1,
+ ):
+ if self.pair_bias_attn:
+ B, N, M, D = bias.shape
+ L = len(self.layers)
+ bias = bias.view(B, N, M, L, D // L)
+
+ for i, layer in enumerate(self.layers):
+ if self.pair_bias_attn:
+ bias_l = bias[:, :, :, i]
+ else:
+ bias_l = None
+
+ if self.activation_checkpointing and self.training:
+ a = torch.utils.checkpoint.checkpoint(
+ layer,
+ a,
+ s,
+ bias_l,
+ mask,
+ to_keys,
+ multiplicity,
+ )
+
+ else:
+ a = layer(
+ a, # Float['bm n d'],
+ s, # Float['bm n ds'],
+ bias_l, # Float['b n n dp']
+ mask, # Bool['b n'] | None = None
+ to_keys,
+ multiplicity,
+ )
+ return a
+
+
+class DiffusionTransformerLayer(Module):
+ """Algorithm 23"""
+
+ def __init__(
+ self,
+ heads,
+ dim=384,
+ dim_single_cond=None,
+ post_layer_norm=False,
+ ):
+ super().__init__()
+
+ dim_single_cond = default(dim_single_cond, dim)
+
+ self.adaln = AdaLN(dim, dim_single_cond)
+ self.pair_bias_attn = AttentionPairBias(
+ c_s=dim, num_heads=heads, compute_pair_bias=False
+ )
+
+ self.output_projection_linear = Linear(dim_single_cond, dim)
+ nn.init.zeros_(self.output_projection_linear.weight)
+ nn.init.constant_(self.output_projection_linear.bias, -2.0)
+
+ self.output_projection = nn.Sequential(
+ self.output_projection_linear, nn.Sigmoid()
+ )
+ self.transition = ConditionedTransitionBlock(
+ dim_single=dim, dim_single_cond=dim_single_cond
+ )
+
+ if post_layer_norm:
+ self.post_lnorm = nn.LayerNorm(dim)
+ else:
+ self.post_lnorm = nn.Identity()
+
+ def forward(
+ self,
+ a, # Float['bm n d'],
+ s, # Float['bm n ds'],
+ bias=None, # Float['b n n dp']
+ mask=None, # Bool['b n'] | None = None
+ to_keys=None,
+ multiplicity=1,
+ ):
+ b = self.adaln(a, s)
+
+ k_in = b
+ if to_keys is not None:
+ k_in = to_keys(b)
+ mask = to_keys(mask.unsqueeze(-1)).squeeze(-1)
+
+ if self.pair_bias_attn:
+ b = self.pair_bias_attn(
+ s=b,
+ z=bias,
+ mask=mask,
+ multiplicity=multiplicity,
+ k_in=k_in,
+ )
+ else:
+ b = self.no_pair_bias_attn(s=b, mask=mask, k_in=k_in)
+
+ b = self.output_projection(s) * b
+
+ a = a + b
+ a = a + self.transition(a, s)
+
+ a = self.post_lnorm(a)
+ return a
+
+
+class AtomTransformer(Module):
+ """Algorithm 7"""
+
+ def __init__(
+ self,
+ attn_window_queries,
+ attn_window_keys,
+ **diffusion_transformer_kwargs,
+ ):
+ super().__init__()
+ self.attn_window_queries = attn_window_queries
+ self.attn_window_keys = attn_window_keys
+ self.diffusion_transformer = DiffusionTransformer(
+ **diffusion_transformer_kwargs
+ )
+
+ def forward(
+ self,
+ q, # Float['b m d'],
+ c, # Float['b m ds'],
+ bias, # Float['b m m dp']
+ to_keys,
+ mask, # Bool['b m'] | None = None
+ multiplicity=1,
+ ):
+ W = self.attn_window_queries
+ H = self.attn_window_keys
+
+ B, N, D = q.shape
+ NW = N // W
+
+ # reshape tokens
+ q = q.view((B * NW, W, -1))
+ c = c.view((B * NW, W, -1))
+ mask = mask.view(B * NW, W)
+ bias = bias.view((bias.shape[0] * NW, W, H, -1))
+
+ to_keys_new = lambda x: to_keys(x.view(B, NW * W, -1)).view(B * NW, H, -1)
+
+ # main transformer
+ q = self.diffusion_transformer(
+ a=q,
+ s=c,
+ bias=bias,
+ mask=mask.float(),
+ multiplicity=multiplicity,
+ to_keys=to_keys_new,
+ )
+
+ q = q.view((B, NW * W, D))
+ return q
diff --git a/forks/boltz/src/boltz/model/modules/trunk.py b/forks/boltz/src/boltz/model/modules/trunk.py
new file mode 100644
index 00000000..a83e0148
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/trunk.py
@@ -0,0 +1,688 @@
+from typing import Optional
+
+import torch
+from fairscale.nn.checkpoint.checkpoint_activations import checkpoint_wrapper
+from torch import Tensor, nn
+
+from boltz.data import const
+from boltz.model.layers.attention import AttentionPairBias
+from boltz.model.layers.dropout import get_dropout_mask
+from boltz.model.layers.outer_product_mean import OuterProductMean
+from boltz.model.layers.pair_averaging import PairWeightedAveraging
+from boltz.model.layers.transition import Transition
+from boltz.model.layers.triangular_attention.attention import (
+ TriangleAttentionEndingNode,
+ TriangleAttentionStartingNode,
+)
+from boltz.model.layers.triangular_mult import (
+ TriangleMultiplicationIncoming,
+ TriangleMultiplicationOutgoing,
+)
+from boltz.model.modules.encoders import AtomAttentionEncoder
+
+
+class InputEmbedder(nn.Module):
+ """Input embedder."""
+
+ def __init__(
+ self,
+ atom_s: int,
+ atom_z: int,
+ token_s: int,
+ token_z: int,
+ atoms_per_window_queries: int,
+ atoms_per_window_keys: int,
+ atom_feature_dim: int,
+ atom_encoder_depth: int,
+ atom_encoder_heads: int,
+ no_atom_encoder: bool = False,
+ ) -> None:
+ """Initialize the input embedder.
+
+ Parameters
+ ----------
+ atom_s : int
+ The atom single representation dimension.
+ atom_z : int
+ The atom pair representation dimension.
+ token_s : int
+ The single token representation dimension.
+ token_z : int
+ The pair token representation dimension.
+ atoms_per_window_queries : int
+ The number of atoms per window for queries.
+ atoms_per_window_keys : int
+ The number of atoms per window for keys.
+ atom_feature_dim : int
+ The atom feature dimension.
+ atom_encoder_depth : int
+ The atom encoder depth.
+ atom_encoder_heads : int
+ The atom encoder heads.
+ no_atom_encoder : bool, optional
+ Whether to use the atom encoder, by default False
+
+ """
+ super().__init__()
+ self.token_s = token_s
+ self.no_atom_encoder = no_atom_encoder
+
+ if not no_atom_encoder:
+ self.atom_attention_encoder = AtomAttentionEncoder(
+ atom_s=atom_s,
+ atom_z=atom_z,
+ token_s=token_s,
+ token_z=token_z,
+ atoms_per_window_queries=atoms_per_window_queries,
+ atoms_per_window_keys=atoms_per_window_keys,
+ atom_feature_dim=atom_feature_dim,
+ atom_encoder_depth=atom_encoder_depth,
+ atom_encoder_heads=atom_encoder_heads,
+ structure_prediction=False,
+ )
+
+ def forward(self, feats: dict[str, Tensor]) -> Tensor:
+ """Perform the forward pass.
+
+ Parameters
+ ----------
+ feats : Dict[str, Tensor]
+ Input features
+
+ Returns
+ -------
+ Tensor
+ The embedded tokens.
+
+ """
+ # Load relevant features
+ res_type = feats["res_type"]
+ profile = feats["profile"]
+ deletion_mean = feats["deletion_mean"].unsqueeze(-1)
+ pocket_feature = feats["pocket_feature"]
+
+ # Compute input embedding
+ if self.no_atom_encoder:
+ a = torch.zeros(
+ (res_type.shape[0], res_type.shape[1], self.token_s),
+ device=res_type.device,
+ )
+ else:
+ a, _, _, _, _ = self.atom_attention_encoder(feats)
+ s = torch.cat([a, res_type, profile, deletion_mean, pocket_feature], dim=-1)
+ return s
+
+
+class MSAModule(nn.Module):
+ """MSA module."""
+
+ def __init__(
+ self,
+ msa_s: int,
+ token_z: int,
+ s_input_dim: int,
+ msa_blocks: int,
+ msa_dropout: float,
+ z_dropout: float,
+ pairwise_head_width: int = 32,
+ pairwise_num_heads: int = 4,
+ activation_checkpointing: bool = False,
+ use_paired_feature: bool = False,
+ offload_to_cpu: bool = False,
+ subsample_msa: bool = False,
+ num_subsampled_msa: int = 1024,
+ **kwargs,
+ ) -> None:
+ """Initialize the MSA module.
+
+ Parameters
+ ----------
+ msa_s : int
+ The MSA embedding size.
+ token_z : int
+ The token pairwise embedding size.
+ s_input_dim : int
+ The input sequence dimension.
+ msa_blocks : int
+ The number of MSA blocks.
+ msa_dropout : float
+ The MSA dropout.
+ z_dropout : float
+ The pairwise dropout.
+ pairwise_head_width : int, optional
+ The pairwise head width, by default 32
+ pairwise_num_heads : int, optional
+ The number of pairwise heads, by default 4
+ activation_checkpointing : bool, optional
+ Whether to use activation checkpointing, by default False
+ use_paired_feature : bool, optional
+ Whether to use the paired feature, by default False
+ offload_to_cpu : bool, optional
+ Whether to offload to CPU, by default False
+
+ """
+ super().__init__()
+ self.msa_blocks = msa_blocks
+ self.msa_dropout = msa_dropout
+ self.z_dropout = z_dropout
+ self.use_paired_feature = use_paired_feature
+ self.subsample_msa = subsample_msa
+ self.num_subsampled_msa = num_subsampled_msa
+
+ self.s_proj = nn.Linear(s_input_dim, msa_s, bias=False)
+ self.msa_proj = nn.Linear(
+ const.num_tokens + 2 + int(use_paired_feature),
+ msa_s,
+ bias=False,
+ )
+ self.layers = nn.ModuleList()
+ for i in range(msa_blocks):
+ if activation_checkpointing:
+ self.layers.append(
+ checkpoint_wrapper(
+ MSALayer(
+ msa_s,
+ token_z,
+ msa_dropout,
+ z_dropout,
+ pairwise_head_width,
+ pairwise_num_heads,
+ ),
+ offload_to_cpu=offload_to_cpu,
+ )
+ )
+ else:
+ self.layers.append(
+ MSALayer(
+ msa_s,
+ token_z,
+ msa_dropout,
+ z_dropout,
+ pairwise_head_width,
+ pairwise_num_heads,
+ )
+ )
+
+ def forward(
+ self,
+ z: Tensor,
+ emb: Tensor,
+ feats: dict[str, Tensor],
+ use_kernels: bool = False,
+ ) -> Tensor:
+ """Perform the forward pass.
+
+ Parameters
+ ----------
+ z : Tensor
+ The pairwise embeddings
+ emb : Tensor
+ The input embeddings
+ feats : dict[str, Tensor]
+ Input features
+
+ Returns
+ -------
+ Tensor
+ The output pairwise embeddings.
+
+ """
+ # Set chunk sizes
+ if not self.training:
+ if z.shape[1] > const.chunk_size_threshold:
+ chunk_heads_pwa = True
+ chunk_size_transition_z = 64
+ chunk_size_transition_msa = 32
+ chunk_size_outer_product = 4
+ chunk_size_tri_attn = 128
+ else:
+ chunk_heads_pwa = False
+ chunk_size_transition_z = None
+ chunk_size_transition_msa = None
+ chunk_size_outer_product = None
+ chunk_size_tri_attn = 512
+ else:
+ chunk_heads_pwa = False
+ chunk_size_transition_z = None
+ chunk_size_transition_msa = None
+ chunk_size_outer_product = None
+ chunk_size_tri_attn = None
+
+ # Load relevant features
+ msa = feats["msa"]
+ has_deletion = feats["has_deletion"].unsqueeze(-1)
+ deletion_value = feats["deletion_value"].unsqueeze(-1)
+ is_paired = feats["msa_paired"].unsqueeze(-1)
+ msa_mask = feats["msa_mask"]
+ token_mask = feats["token_pad_mask"].float()
+ token_mask = token_mask[:, :, None] * token_mask[:, None, :]
+
+ # Compute MSA embeddings
+ if self.use_paired_feature:
+ m = torch.cat([msa, has_deletion, deletion_value, is_paired], dim=-1)
+ else:
+ m = torch.cat([msa, has_deletion, deletion_value], dim=-1)
+
+ if self.subsample_msa:
+ msa_indices = torch.randperm(m.shape[1])[: self.num_subsampled_msa]
+ m = m[:, msa_indices]
+ msa_mask = msa_mask[:, msa_indices]
+
+ # Compute input projections
+ m = self.msa_proj(m)
+ m = m + self.s_proj(emb).unsqueeze(1)
+
+ # Perform MSA blocks
+ for i in range(self.msa_blocks):
+ z, m = self.layers[i](
+ z,
+ m,
+ token_mask,
+ msa_mask,
+ chunk_heads_pwa,
+ chunk_size_transition_z,
+ chunk_size_transition_msa,
+ chunk_size_outer_product,
+ chunk_size_tri_attn,
+ use_kernels=use_kernels,
+ )
+ return z
+
+
+class MSALayer(nn.Module):
+ """MSA module."""
+
+ def __init__(
+ self,
+ msa_s: int,
+ token_z: int,
+ msa_dropout: float,
+ z_dropout: float,
+ pairwise_head_width: int = 32,
+ pairwise_num_heads: int = 4,
+ ) -> None:
+ """Initialize the MSA module.
+
+ Parameters
+ ----------
+
+ msa_s : int
+ The MSA embedding size.
+ token_z : int
+ The pair representation dimention.
+ msa_dropout : float
+ The MSA dropout.
+ z_dropout : float
+ The pair dropout.
+ pairwise_head_width : int, optional
+ The pairwise head width, by default 32
+ pairwise_num_heads : int, optional
+ The number of pairwise heads, by default 4
+
+ """
+ super().__init__()
+ self.msa_dropout = msa_dropout
+ self.z_dropout = z_dropout
+ self.msa_transition = Transition(dim=msa_s, hidden=msa_s * 4)
+ self.pair_weighted_averaging = PairWeightedAveraging(
+ c_m=msa_s,
+ c_z=token_z,
+ c_h=32,
+ num_heads=8,
+ )
+
+ self.tri_mul_out = TriangleMultiplicationOutgoing(token_z)
+ self.tri_mul_in = TriangleMultiplicationIncoming(token_z)
+ self.tri_att_start = TriangleAttentionStartingNode(
+ token_z, pairwise_head_width, pairwise_num_heads, inf=1e9
+ )
+ self.tri_att_end = TriangleAttentionEndingNode(
+ token_z, pairwise_head_width, pairwise_num_heads, inf=1e9
+ )
+ self.z_transition = Transition(
+ dim=token_z,
+ hidden=token_z * 4,
+ )
+ self.outer_product_mean = OuterProductMean(
+ c_in=msa_s,
+ c_hidden=32,
+ c_out=token_z,
+ )
+
+ def forward(
+ self,
+ z: Tensor,
+ m: Tensor,
+ token_mask: Tensor,
+ msa_mask: Tensor,
+ chunk_heads_pwa: bool = False,
+ chunk_size_transition_z: int = None,
+ chunk_size_transition_msa: int = None,
+ chunk_size_outer_product: int = None,
+ chunk_size_tri_attn: int = None,
+ use_kernels: bool = False,
+ ) -> tuple[Tensor, Tensor]:
+ """Perform the forward pass.
+
+ Parameters
+ ----------
+ z : Tensor
+ The pair representation
+ m : Tensor
+ The msa representation
+ token_mask : Tensor
+ The token mask
+ msa_mask : Dict[str, Tensor]
+ The MSA mask
+
+ Returns
+ -------
+ Tensor
+ The output pairwise embeddings.
+ Tensor
+ The output MSA embeddings.
+
+ """
+ # Communication to MSA stack
+ msa_dropout = get_dropout_mask(self.msa_dropout, m, self.training)
+ m = m + msa_dropout * self.pair_weighted_averaging(
+ m, z, token_mask, chunk_heads_pwa
+ )
+ m = m + self.msa_transition(m, chunk_size_transition_msa)
+
+ # Communication to pairwise stack
+ z = z + self.outer_product_mean(m, msa_mask, chunk_size_outer_product)
+
+ # Compute pairwise stack
+ dropout = get_dropout_mask(self.z_dropout, z, self.training)
+ z = z + dropout * self.tri_mul_out(z, mask=token_mask)
+
+ dropout = get_dropout_mask(self.z_dropout, z, self.training)
+ z = z + dropout * self.tri_mul_in(z, mask=token_mask)
+
+ dropout = get_dropout_mask(self.z_dropout, z, self.training)
+ z = z + dropout * self.tri_att_start(
+ z,
+ mask=token_mask,
+ chunk_size=chunk_size_tri_attn,
+ use_kernels=use_kernels,
+ )
+
+ dropout = get_dropout_mask(self.z_dropout, z, self.training, columnwise=True)
+ z = z + dropout * self.tri_att_end(
+ z,
+ mask=token_mask,
+ chunk_size=chunk_size_tri_attn,
+ use_kernels=use_kernels,
+ )
+
+ z = z + self.z_transition(z, chunk_size_transition_z)
+
+ return z, m
+
+
+class PairformerModule(nn.Module):
+ """Pairformer module."""
+
+ def __init__(
+ self,
+ token_s: int,
+ token_z: int,
+ num_blocks: int,
+ num_heads: int = 16,
+ dropout: float = 0.25,
+ pairwise_head_width: int = 32,
+ pairwise_num_heads: int = 4,
+ activation_checkpointing: bool = False,
+ no_update_s: bool = False,
+ no_update_z: bool = False,
+ offload_to_cpu: bool = False,
+ **kwargs,
+ ) -> None:
+ """Initialize the Pairformer module.
+
+ Parameters
+ ----------
+ token_s : int
+ The token single embedding size.
+ token_z : int
+ The token pairwise embedding size.
+ num_blocks : int
+ The number of blocks.
+ num_heads : int, optional
+ The number of heads, by default 16
+ dropout : float, optional
+ The dropout rate, by default 0.25
+ pairwise_head_width : int, optional
+ The pairwise head width, by default 32
+ pairwise_num_heads : int, optional
+ The number of pairwise heads, by default 4
+ activation_checkpointing : bool, optional
+ Whether to use activation checkpointing, by default False
+ no_update_s : bool, optional
+ Whether to update the single embeddings, by default False
+ no_update_z : bool, optional
+ Whether to update the pairwise embeddings, by default False
+ offload_to_cpu : bool, optional
+ Whether to offload to CPU, by default False
+
+ """
+ super().__init__()
+ self.token_z = token_z
+ self.num_blocks = num_blocks
+ self.dropout = dropout
+ self.num_heads = num_heads
+
+ self.layers = nn.ModuleList()
+ for i in range(num_blocks):
+ if activation_checkpointing:
+ self.layers.append(
+ checkpoint_wrapper(
+ PairformerLayer(
+ token_s,
+ token_z,
+ num_heads,
+ dropout,
+ pairwise_head_width,
+ pairwise_num_heads,
+ no_update_s,
+ False if i < num_blocks - 1 else no_update_z,
+ ),
+ offload_to_cpu=offload_to_cpu,
+ )
+ )
+ else:
+ self.layers.append(
+ PairformerLayer(
+ token_s,
+ token_z,
+ num_heads,
+ dropout,
+ pairwise_head_width,
+ pairwise_num_heads,
+ no_update_s,
+ False if i < num_blocks - 1 else no_update_z,
+ )
+ )
+
+ def forward(
+ self,
+ s: Tensor,
+ z: Tensor,
+ mask: Tensor,
+ pair_mask: Tensor,
+ chunk_size_tri_attn: Optional[int] = None,
+ use_kernels: bool = False,
+ ) -> tuple[Tensor, Tensor]:
+ """Perform the forward pass.
+
+ Parameters
+ ----------
+ s : Tensor
+ The sequence embeddings
+ z : Tensor
+ The pairwise embeddings
+ mask : Tensor
+ The token mask
+ pair_mask : Tensor
+ The pairwise mask
+ Returns
+ -------
+ Tensor
+ The updated sequence embeddings.
+ Tensor
+ The updated pairwise embeddings.
+
+ """
+ if not self.training:
+ if z.shape[1] > const.chunk_size_threshold:
+ chunk_size_tri_attn = 128
+ else:
+ chunk_size_tri_attn = 512
+ else:
+ chunk_size_tri_attn = None
+
+ for layer in self.layers:
+ s, z = layer(
+ s,
+ z,
+ mask,
+ pair_mask,
+ chunk_size_tri_attn,
+ use_kernels=use_kernels,
+ )
+ return s, z
+
+
+class PairformerLayer(nn.Module):
+ """Pairformer module."""
+
+ def __init__(
+ self,
+ token_s: int,
+ token_z: int,
+ num_heads: int = 16,
+ dropout: float = 0.25,
+ pairwise_head_width: int = 32,
+ pairwise_num_heads: int = 4,
+ no_update_s: bool = False,
+ no_update_z: bool = False,
+ ) -> None:
+ """Initialize the Pairformer module.
+
+ Parameters
+ ----------
+ token_s : int
+ The token single embedding size.
+ token_z : int
+ The token pairwise embedding size.
+ num_heads : int, optional
+ The number of heads, by default 16
+ dropout : float, optiona
+ The dropout rate, by default 0.25
+ pairwise_head_width : int, optional
+ The pairwise head width, by default 32
+ pairwise_num_heads : int, optional
+ The number of pairwise heads, by default 4
+ no_update_s : bool, optional
+ Whether to update the single embeddings, by default False
+ no_update_z : bool, optional
+ Whether to update the pairwise embeddings, by default False
+
+ """
+ super().__init__()
+ self.token_z = token_z
+ self.dropout = dropout
+ self.num_heads = num_heads
+ self.no_update_s = no_update_s
+ self.no_update_z = no_update_z
+ if not self.no_update_s:
+ self.attention = AttentionPairBias(token_s, token_z, num_heads)
+ self.tri_mul_out = TriangleMultiplicationOutgoing(token_z)
+ self.tri_mul_in = TriangleMultiplicationIncoming(token_z)
+ self.tri_att_start = TriangleAttentionStartingNode(
+ token_z, pairwise_head_width, pairwise_num_heads, inf=1e9
+ )
+ self.tri_att_end = TriangleAttentionEndingNode(
+ token_z, pairwise_head_width, pairwise_num_heads, inf=1e9
+ )
+ if not self.no_update_s:
+ self.transition_s = Transition(token_s, token_s * 4)
+ self.transition_z = Transition(token_z, token_z * 4)
+
+ def forward(
+ self,
+ s: Tensor,
+ z: Tensor,
+ mask: Tensor,
+ pair_mask: Tensor,
+ chunk_size_tri_attn: Optional[int] = None,
+ use_kernels: bool = False,
+ ) -> tuple[Tensor, Tensor]:
+ """Perform the forward pass."""
+ # Compute pairwise stack
+ dropout = get_dropout_mask(self.dropout, z, self.training)
+ z = z + dropout * self.tri_mul_out(z, mask=pair_mask)
+
+ dropout = get_dropout_mask(self.dropout, z, self.training)
+ z = z + dropout * self.tri_mul_in(z, mask=pair_mask)
+
+ dropout = get_dropout_mask(self.dropout, z, self.training)
+ z = z + dropout * self.tri_att_start(
+ z,
+ mask=pair_mask,
+ chunk_size=chunk_size_tri_attn,
+ use_kernels=use_kernels,
+ )
+
+ dropout = get_dropout_mask(self.dropout, z, self.training, columnwise=True)
+ z = z + dropout * self.tri_att_end(
+ z,
+ mask=pair_mask,
+ chunk_size=chunk_size_tri_attn,
+ use_kernels=use_kernels,
+ )
+
+ z = z + self.transition_z(z)
+
+ # Compute sequence stack
+ if not self.no_update_s:
+ s = s + self.attention(s, z, mask)
+ s = s + self.transition_s(s)
+
+ return s, z
+
+
+class DistogramModule(nn.Module):
+ """Distogram Module."""
+
+ def __init__(self, token_z: int, num_bins: int) -> None:
+ """Initialize the distogram module.
+
+ Parameters
+ ----------
+ token_z : int
+ The token pairwise embedding size.
+ num_bins : int
+ The number of bins.
+
+ """
+ super().__init__()
+ self.distogram = nn.Linear(token_z, num_bins)
+
+ def forward(self, z: Tensor) -> Tensor:
+ """Perform the forward pass.
+
+ Parameters
+ ----------
+ z : Tensor
+ The pairwise embeddings
+
+ Returns
+ -------
+ Tensor
+ The predicted distogram.
+
+ """
+ z = z + z.transpose(1, 2)
+ return self.distogram(z)
diff --git a/forks/boltz/src/boltz/model/modules/trunkv2.py b/forks/boltz/src/boltz/model/modules/trunkv2.py
new file mode 100644
index 00000000..ebd7a2ec
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/trunkv2.py
@@ -0,0 +1,828 @@
+import torch
+from torch import Tensor, nn
+from torch.nn.functional import one_hot
+
+from boltz.data import const
+from boltz.model.layers.outer_product_mean import OuterProductMean
+from boltz.model.layers.pair_averaging import PairWeightedAveraging
+from boltz.model.layers.pairformer import (
+ PairformerNoSeqLayer,
+ PairformerNoSeqModule,
+ get_dropout_mask,
+)
+from boltz.model.layers.transition import Transition
+from boltz.model.modules.encodersv2 import (
+ AtomAttentionEncoder,
+ AtomEncoder,
+ FourierEmbedding,
+)
+
+
+class ContactConditioning(nn.Module):
+ def __init__(self, token_z: int, cutoff_min: float, cutoff_max: float):
+ super().__init__()
+
+ self.fourier_embedding = FourierEmbedding(token_z)
+ self.encoder = nn.Linear(
+ token_z + len(const.contact_conditioning_info) - 1, token_z
+ )
+ self.encoding_unspecified = nn.Parameter(torch.zeros(token_z))
+ self.encoding_unselected = nn.Parameter(torch.zeros(token_z))
+ self.cutoff_min = cutoff_min
+ self.cutoff_max = cutoff_max
+
+ def forward(self, feats):
+ assert const.contact_conditioning_info["UNSPECIFIED"] == 0
+ assert const.contact_conditioning_info["UNSELECTED"] == 1
+ contact_conditioning = feats["contact_conditioning"][:, :, :, 2:]
+ contact_threshold = feats["contact_threshold"]
+ contact_threshold_normalized = (contact_threshold - self.cutoff_min) / (
+ self.cutoff_max - self.cutoff_min
+ )
+ contact_threshold_fourier = self.fourier_embedding(
+ contact_threshold_normalized.flatten()
+ ).reshape(contact_threshold_normalized.shape + (-1,))
+
+ contact_conditioning = torch.cat(
+ [
+ contact_conditioning,
+ contact_threshold_normalized.unsqueeze(-1),
+ contact_threshold_fourier,
+ ],
+ dim=-1,
+ )
+ contact_conditioning = self.encoder(contact_conditioning)
+
+ contact_conditioning = (
+ contact_conditioning
+ * (
+ 1
+ - feats["contact_conditioning"][:, :, :, 0:2].sum(dim=-1, keepdim=True)
+ )
+ + self.encoding_unspecified * feats["contact_conditioning"][:, :, :, 0:1]
+ + self.encoding_unselected * feats["contact_conditioning"][:, :, :, 1:2]
+ )
+ return contact_conditioning
+
+
+class InputEmbedder(nn.Module):
+ def __init__(
+ self,
+ atom_s: int,
+ atom_z: int,
+ token_s: int,
+ token_z: int,
+ atoms_per_window_queries: int,
+ atoms_per_window_keys: int,
+ atom_feature_dim: int,
+ atom_encoder_depth: int,
+ atom_encoder_heads: int,
+ activation_checkpointing: bool = False,
+ add_method_conditioning: bool = False,
+ add_modified_flag: bool = False,
+ add_cyclic_flag: bool = False,
+ add_mol_type_feat: bool = False,
+ use_no_atom_char: bool = False,
+ use_atom_backbone_feat: bool = False,
+ use_residue_feats_atoms: bool = False,
+ ) -> None:
+ """Initialize the input embedder.
+
+ Parameters
+ ----------
+ atom_s : int
+ The atom embedding size.
+ atom_z : int
+ The atom pairwise embedding size.
+ token_s : int
+ The token embedding size.
+
+ """
+ super().__init__()
+ self.token_s = token_s
+ self.add_method_conditioning = add_method_conditioning
+ self.add_modified_flag = add_modified_flag
+ self.add_cyclic_flag = add_cyclic_flag
+ self.add_mol_type_feat = add_mol_type_feat
+
+ self.atom_encoder = AtomEncoder(
+ atom_s=atom_s,
+ atom_z=atom_z,
+ token_s=token_s,
+ token_z=token_z,
+ atoms_per_window_queries=atoms_per_window_queries,
+ atoms_per_window_keys=atoms_per_window_keys,
+ atom_feature_dim=atom_feature_dim,
+ structure_prediction=False,
+ use_no_atom_char=use_no_atom_char,
+ use_atom_backbone_feat=use_atom_backbone_feat,
+ use_residue_feats_atoms=use_residue_feats_atoms,
+ )
+
+ self.atom_enc_proj_z = nn.Sequential(
+ nn.LayerNorm(atom_z),
+ nn.Linear(atom_z, atom_encoder_depth * atom_encoder_heads, bias=False),
+ )
+
+ self.atom_attention_encoder = AtomAttentionEncoder(
+ atom_s=atom_s,
+ token_s=token_s,
+ atoms_per_window_queries=atoms_per_window_queries,
+ atoms_per_window_keys=atoms_per_window_keys,
+ atom_encoder_depth=atom_encoder_depth,
+ atom_encoder_heads=atom_encoder_heads,
+ structure_prediction=False,
+ activation_checkpointing=activation_checkpointing,
+ )
+
+ self.res_type_encoding = nn.Linear(const.num_tokens, token_s, bias=False)
+ self.msa_profile_encoding = nn.Linear(const.num_tokens + 1, token_s, bias=False)
+
+ if add_method_conditioning:
+ self.method_conditioning_init = nn.Embedding(
+ const.num_method_types, token_s
+ )
+ self.method_conditioning_init.weight.data.fill_(0)
+ if add_modified_flag:
+ self.modified_conditioning_init = nn.Embedding(2, token_s)
+ self.modified_conditioning_init.weight.data.fill_(0)
+ if add_cyclic_flag:
+ self.cyclic_conditioning_init = nn.Linear(1, token_s, bias=False)
+ self.cyclic_conditioning_init.weight.data.fill_(0)
+ if add_mol_type_feat:
+ self.mol_type_conditioning_init = nn.Embedding(
+ len(const.chain_type_ids), token_s
+ )
+ self.mol_type_conditioning_init.weight.data.fill_(0)
+
+ def forward(self, feats: dict[str, Tensor], affinity: bool = False) -> Tensor:
+ """Perform the forward pass.
+
+ Parameters
+ ----------
+ feats : dict[str, Tensor]
+ Input features
+
+ Returns
+ -------
+ Tensor
+ The embedded tokens.
+
+ """
+ # Load relevant features
+ res_type = feats["res_type"].float()
+ if affinity:
+ profile = feats["profile_affinity"]
+ deletion_mean = feats["deletion_mean_affinity"].unsqueeze(-1)
+ else:
+ profile = feats["profile"]
+ deletion_mean = feats["deletion_mean"].unsqueeze(-1)
+
+ # Compute input embedding
+ q, c, p, to_keys = self.atom_encoder(feats)
+ atom_enc_bias = self.atom_enc_proj_z(p)
+ a, _, _, _ = self.atom_attention_encoder(
+ feats=feats,
+ q=q,
+ c=c,
+ atom_enc_bias=atom_enc_bias,
+ to_keys=to_keys,
+ )
+
+ s = (
+ a
+ + self.res_type_encoding(res_type)
+ + self.msa_profile_encoding(torch.cat([profile, deletion_mean], dim=-1))
+ )
+
+ if self.add_method_conditioning:
+ s = s + self.method_conditioning_init(feats["method_feature"])
+ if self.add_modified_flag:
+ s = s + self.modified_conditioning_init(feats["modified"])
+ if self.add_cyclic_flag:
+ cyclic = feats["cyclic_period"].clamp(max=1.0).unsqueeze(-1)
+ s = s + self.cyclic_conditioning_init(cyclic)
+ if self.add_mol_type_feat:
+ s = s + self.mol_type_conditioning_init(feats["mol_type"])
+
+ return s
+
+
+class TemplateModule(nn.Module):
+ """Template module."""
+
+ def __init__(
+ self,
+ token_z: int,
+ template_dim: int,
+ template_blocks: int,
+ dropout: float = 0.25,
+ pairwise_head_width: int = 32,
+ pairwise_num_heads: int = 4,
+ post_layer_norm: bool = False,
+ activation_checkpointing: bool = False,
+ min_dist: float = 3.25,
+ max_dist: float = 50.75,
+ num_bins: int = 38,
+ **kwargs,
+ ) -> None:
+ """Initialize the template module.
+
+ Parameters
+ ----------
+ token_z : int
+ The token pairwise embedding size.
+
+ """
+ super().__init__()
+ self.min_dist = min_dist
+ self.max_dist = max_dist
+ self.num_bins = num_bins
+ self.relu = nn.ReLU()
+ self.z_norm = nn.LayerNorm(token_z)
+ self.v_norm = nn.LayerNorm(template_dim)
+ self.z_proj = nn.Linear(token_z, template_dim, bias=False)
+ self.a_proj = nn.Linear(
+ const.num_tokens * 2 + num_bins + 5,
+ template_dim,
+ bias=False,
+ )
+ self.u_proj = nn.Linear(template_dim, token_z, bias=False)
+ self.pairformer = PairformerNoSeqModule(
+ template_dim,
+ num_blocks=template_blocks,
+ dropout=dropout,
+ pairwise_head_width=pairwise_head_width,
+ pairwise_num_heads=pairwise_num_heads,
+ post_layer_norm=post_layer_norm,
+ activation_checkpointing=activation_checkpointing,
+ )
+
+ def forward(
+ self,
+ z: Tensor,
+ feats: dict[str, Tensor],
+ pair_mask: Tensor,
+ use_kernels: bool = False,
+ ) -> Tensor:
+ """Perform the forward pass.
+
+ Parameters
+ ----------
+ z : Tensor
+ The pairwise embeddings
+ feats : dict[str, Tensor]
+ Input features
+ pair_mask : Tensor
+ The pair mask
+
+ Returns
+ -------
+ Tensor
+ The updated pairwise embeddings.
+
+ """
+ # Load relevant features
+ asym_id = feats["asym_id"]
+ res_type = feats["template_restype"]
+ frame_rot = feats["template_frame_rot"]
+ frame_t = feats["template_frame_t"]
+ frame_mask = feats["template_mask_frame"]
+ cb_coords = feats["template_cb"]
+ ca_coords = feats["template_ca"]
+ cb_mask = feats["template_mask_cb"]
+ template_mask = feats["template_mask"].any(dim=2).float()
+ num_templates = template_mask.sum(dim=1)
+ num_templates = num_templates.clamp(min=1)
+
+ # Compute pairwise masks
+ b_cb_mask = cb_mask[:, :, :, None] * cb_mask[:, :, None, :]
+ b_frame_mask = frame_mask[:, :, :, None] * frame_mask[:, :, None, :]
+
+ b_cb_mask = b_cb_mask[..., None]
+ b_frame_mask = b_frame_mask[..., None]
+
+ # Compute asym mask, template features only attend within the same chain
+ B, T = res_type.shape[:2] # noqa: N806
+ asym_mask = (asym_id[:, :, None] == asym_id[:, None, :]).float()
+ asym_mask = asym_mask[:, None].expand(-1, T, -1, -1)
+
+ # Compute template features
+ with torch.autocast(device_type="cuda", enabled=False):
+ # Compute distogram
+ cb_dists = torch.cdist(cb_coords, cb_coords)
+ boundaries = torch.linspace(self.min_dist, self.max_dist, self.num_bins - 1)
+ boundaries = boundaries.to(cb_dists.device)
+ distogram = (cb_dists[..., None] > boundaries).sum(dim=-1).long()
+ distogram = one_hot(distogram, num_classes=self.num_bins)
+
+ # Compute unit vector in each frame
+ frame_rot = frame_rot.unsqueeze(2).transpose(-1, -2)
+ frame_t = frame_t.unsqueeze(2).unsqueeze(-1)
+ ca_coords = ca_coords.unsqueeze(3).unsqueeze(-1)
+ vector = torch.matmul(frame_rot, (ca_coords - frame_t))
+ norm = torch.norm(vector, dim=-1, keepdim=True)
+ unit_vector = torch.where(norm > 0, vector / norm, torch.zeros_like(vector))
+ unit_vector = unit_vector.squeeze(-1)
+
+ # Concatenate input features
+ a_tij = [distogram, b_cb_mask, unit_vector, b_frame_mask]
+ a_tij = torch.cat(a_tij, dim=-1)
+ a_tij = a_tij * asym_mask.unsqueeze(-1)
+
+ res_type_i = res_type[:, :, :, None]
+ res_type_j = res_type[:, :, None, :]
+ res_type_i = res_type_i.expand(-1, -1, -1, res_type.size(2), -1)
+ res_type_j = res_type_j.expand(-1, -1, res_type.size(2), -1, -1)
+ a_tij = torch.cat([a_tij, res_type_i, res_type_j], dim=-1)
+ a_tij = self.a_proj(a_tij)
+
+ # Expand mask
+ pair_mask = pair_mask[:, None].expand(-1, T, -1, -1)
+ pair_mask = pair_mask.reshape(B * T, *pair_mask.shape[2:])
+
+ # Compute input projections
+ v = self.z_proj(self.z_norm(z[:, None])) + a_tij
+ v = v.view(B * T, *v.shape[2:])
+ v = v + self.pairformer(v, pair_mask, use_kernels=use_kernels)
+ v = self.v_norm(v)
+ v = v.view(B, T, *v.shape[1:])
+
+ # Aggregate templates
+ template_mask = template_mask[:, :, None, None, None]
+ num_templates = num_templates[:, None, None, None]
+ u = (v * template_mask).sum(dim=1) / num_templates.to(v)
+
+ # Compute output projection
+ u = self.u_proj(self.relu(u))
+ return u
+
+
+class TemplateV2Module(nn.Module):
+ """Template module."""
+
+ def __init__(
+ self,
+ token_z: int,
+ template_dim: int,
+ template_blocks: int,
+ dropout: float = 0.25,
+ pairwise_head_width: int = 32,
+ pairwise_num_heads: int = 4,
+ post_layer_norm: bool = False,
+ activation_checkpointing: bool = False,
+ min_dist: float = 3.25,
+ max_dist: float = 50.75,
+ num_bins: int = 38,
+ **kwargs,
+ ) -> None:
+ """Initialize the template module.
+
+ Parameters
+ ----------
+ token_z : int
+ The token pairwise embedding size.
+
+ """
+ super().__init__()
+ self.min_dist = min_dist
+ self.max_dist = max_dist
+ self.num_bins = num_bins
+ self.relu = nn.ReLU()
+ self.z_norm = nn.LayerNorm(token_z)
+ self.v_norm = nn.LayerNorm(template_dim)
+ self.z_proj = nn.Linear(token_z, template_dim, bias=False)
+ self.a_proj = nn.Linear(
+ const.num_tokens * 2 + num_bins + 5,
+ template_dim,
+ bias=False,
+ )
+ self.u_proj = nn.Linear(template_dim, token_z, bias=False)
+ self.pairformer = PairformerNoSeqModule(
+ template_dim,
+ num_blocks=template_blocks,
+ dropout=dropout,
+ pairwise_head_width=pairwise_head_width,
+ pairwise_num_heads=pairwise_num_heads,
+ post_layer_norm=post_layer_norm,
+ activation_checkpointing=activation_checkpointing,
+ )
+
+ def forward(
+ self,
+ z: Tensor,
+ feats: dict[str, Tensor],
+ pair_mask: Tensor,
+ use_kernels: bool = False,
+ ) -> Tensor:
+ """Perform the forward pass.
+
+ Parameters
+ ----------
+ z : Tensor
+ The pairwise embeddings
+ feats : dict[str, Tensor]
+ Input features
+ pair_mask : Tensor
+ The pair mask
+
+ Returns
+ -------
+ Tensor
+ The updated pairwise embeddings.
+
+ """
+ # Load relevant features
+ res_type = feats["template_restype"]
+ frame_rot = feats["template_frame_rot"]
+ frame_t = feats["template_frame_t"]
+ frame_mask = feats["template_mask_frame"]
+ cb_coords = feats["template_cb"]
+ ca_coords = feats["template_ca"]
+ cb_mask = feats["template_mask_cb"]
+ visibility_ids = feats["visibility_ids"]
+ template_mask = feats["template_mask"].any(dim=2).float()
+ num_templates = template_mask.sum(dim=1)
+ num_templates = num_templates.clamp(min=1)
+
+ # Compute pairwise masks
+ b_cb_mask = cb_mask[:, :, :, None] * cb_mask[:, :, None, :]
+ b_frame_mask = frame_mask[:, :, :, None] * frame_mask[:, :, None, :]
+
+ b_cb_mask = b_cb_mask[..., None]
+ b_frame_mask = b_frame_mask[..., None]
+
+ # Compute asym mask, template features only attend within the same chain
+ B, T = res_type.shape[:2] # noqa: N806
+ tmlp_pair_mask = (
+ visibility_ids[:, :, :, None] == visibility_ids[:, :, None, :]
+ ).float()
+
+ # Compute template features
+ with torch.autocast(device_type="cuda", enabled=False):
+ # Compute distogram
+ cb_dists = torch.cdist(cb_coords, cb_coords)
+ boundaries = torch.linspace(self.min_dist, self.max_dist, self.num_bins - 1)
+ boundaries = boundaries.to(cb_dists.device)
+ distogram = (cb_dists[..., None] > boundaries).sum(dim=-1).long()
+ distogram = one_hot(distogram, num_classes=self.num_bins)
+
+ # Compute unit vector in each frame
+ frame_rot = frame_rot.unsqueeze(2).transpose(-1, -2)
+ frame_t = frame_t.unsqueeze(2).unsqueeze(-1)
+ ca_coords = ca_coords.unsqueeze(3).unsqueeze(-1)
+ vector = torch.matmul(frame_rot, (ca_coords - frame_t))
+ norm = torch.norm(vector, dim=-1, keepdim=True)
+ unit_vector = torch.where(norm > 0, vector / norm, torch.zeros_like(vector))
+ unit_vector = unit_vector.squeeze(-1)
+
+ # Concatenate input features
+ a_tij = [distogram, b_cb_mask, unit_vector, b_frame_mask]
+ a_tij = torch.cat(a_tij, dim=-1)
+ a_tij = a_tij * tmlp_pair_mask.unsqueeze(-1)
+
+ res_type_i = res_type[:, :, :, None]
+ res_type_j = res_type[:, :, None, :]
+ res_type_i = res_type_i.expand(-1, -1, -1, res_type.size(2), -1)
+ res_type_j = res_type_j.expand(-1, -1, res_type.size(2), -1, -1)
+ a_tij = torch.cat([a_tij, res_type_i, res_type_j], dim=-1)
+ a_tij = self.a_proj(a_tij)
+
+ # Expand mask
+ pair_mask = pair_mask[:, None].expand(-1, T, -1, -1)
+ pair_mask = pair_mask.reshape(B * T, *pair_mask.shape[2:])
+
+ # Compute input projections
+ v = self.z_proj(self.z_norm(z[:, None])) + a_tij
+ v = v.view(B * T, *v.shape[2:])
+ v = v + self.pairformer(v, pair_mask, use_kernels=use_kernels)
+ v = self.v_norm(v)
+ v = v.view(B, T, *v.shape[1:])
+
+ # Aggregate templates
+ template_mask = template_mask[:, :, None, None, None]
+ num_templates = num_templates[:, None, None, None]
+ u = (v * template_mask).sum(dim=1) / num_templates.to(v)
+
+ # Compute output projection
+ u = self.u_proj(self.relu(u))
+ return u
+
+
+class MSAModule(nn.Module):
+ """MSA module."""
+
+ def __init__(
+ self,
+ msa_s: int,
+ token_z: int,
+ token_s: int,
+ msa_blocks: int,
+ msa_dropout: float,
+ z_dropout: float,
+ pairwise_head_width: int = 32,
+ pairwise_num_heads: int = 4,
+ activation_checkpointing: bool = False,
+ use_paired_feature: bool = True,
+ subsample_msa: bool = False,
+ num_subsampled_msa: int = 1024,
+ **kwargs,
+ ) -> None:
+ """Initialize the MSA module.
+
+ Parameters
+ ----------
+ token_z : int
+ The token pairwise embedding size.
+
+ """
+ super().__init__()
+ self.msa_blocks = msa_blocks
+ self.msa_dropout = msa_dropout
+ self.z_dropout = z_dropout
+ self.use_paired_feature = use_paired_feature
+ self.activation_checkpointing = activation_checkpointing
+ self.subsample_msa = subsample_msa
+ self.num_subsampled_msa = num_subsampled_msa
+
+ self.s_proj = nn.Linear(token_s, msa_s, bias=False)
+ self.msa_proj = nn.Linear(
+ const.num_tokens + 2 + int(use_paired_feature),
+ msa_s,
+ bias=False,
+ )
+ self.layers = nn.ModuleList()
+ for i in range(msa_blocks):
+ self.layers.append(
+ MSALayer(
+ msa_s,
+ token_z,
+ msa_dropout,
+ z_dropout,
+ pairwise_head_width,
+ pairwise_num_heads,
+ )
+ )
+
+ def forward(
+ self,
+ z: Tensor,
+ emb: Tensor,
+ feats: dict[str, Tensor],
+ use_kernels: bool = False,
+ ) -> Tensor:
+ """Perform the forward pass.
+
+ Parameters
+ ----------
+ z : Tensor
+ The pairwise embeddings
+ emb : Tensor
+ The input embeddings
+ feats : dict[str, Tensor]
+ Input features
+ use_kernels: bool
+ Whether to use kernels for triangular updates
+
+ Returns
+ -------
+ Tensor
+ The output pairwise embeddings.
+
+ """
+ # Set chunk sizes
+ if not self.training:
+ if z.shape[1] > const.chunk_size_threshold:
+ chunk_heads_pwa = True
+ chunk_size_transition_z = 64
+ chunk_size_transition_msa = 32
+ chunk_size_outer_product = 4
+ chunk_size_tri_attn = 128
+ else:
+ chunk_heads_pwa = False
+ chunk_size_transition_z = None
+ chunk_size_transition_msa = None
+ chunk_size_outer_product = None
+ chunk_size_tri_attn = 512
+ else:
+ chunk_heads_pwa = False
+ chunk_size_transition_z = None
+ chunk_size_transition_msa = None
+ chunk_size_outer_product = None
+ chunk_size_tri_attn = None
+
+ # Load relevant features
+ msa = feats["msa"]
+ msa = torch.nn.functional.one_hot(msa, num_classes=const.num_tokens)
+ has_deletion = feats["has_deletion"].unsqueeze(-1)
+ deletion_value = feats["deletion_value"].unsqueeze(-1)
+ is_paired = feats["msa_paired"].unsqueeze(-1)
+ msa_mask = feats["msa_mask"]
+ token_mask = feats["token_pad_mask"].float()
+ token_mask = token_mask[:, :, None] * token_mask[:, None, :]
+
+ # Compute MSA embeddings
+ if self.use_paired_feature:
+ m = torch.cat([msa, has_deletion, deletion_value, is_paired], dim=-1)
+ else:
+ m = torch.cat([msa, has_deletion, deletion_value], dim=-1)
+
+ # Subsample the MSA
+ if self.subsample_msa:
+ msa_indices = torch.randperm(msa.shape[1])[: self.num_subsampled_msa]
+ m = m[:, msa_indices]
+ msa_mask = msa_mask[:, msa_indices]
+
+ # Compute input projections
+ m = self.msa_proj(m)
+ m = m + self.s_proj(emb).unsqueeze(1)
+
+ # Perform MSA blocks
+ for i in range(self.msa_blocks):
+ if self.activation_checkpointing and self.training:
+ z, m = torch.utils.checkpoint.checkpoint(
+ self.layers[i],
+ z,
+ m,
+ token_mask,
+ msa_mask,
+ chunk_heads_pwa,
+ chunk_size_transition_z,
+ chunk_size_transition_msa,
+ chunk_size_outer_product,
+ chunk_size_tri_attn,
+ use_kernels,
+ )
+ else:
+ z, m = self.layers[i](
+ z,
+ m,
+ token_mask,
+ msa_mask,
+ chunk_heads_pwa,
+ chunk_size_transition_z,
+ chunk_size_transition_msa,
+ chunk_size_outer_product,
+ chunk_size_tri_attn,
+ use_kernels,
+ )
+ return z
+
+
+class MSALayer(nn.Module):
+ """MSA module."""
+
+ def __init__(
+ self,
+ msa_s: int,
+ token_z: int,
+ msa_dropout: float,
+ z_dropout: float,
+ pairwise_head_width: int = 32,
+ pairwise_num_heads: int = 4,
+ ) -> None:
+ """Initialize the MSA module.
+
+ Parameters
+ ----------
+ token_z : int
+ The token pairwise embedding size.
+
+ """
+ super().__init__()
+ self.msa_dropout = msa_dropout
+ self.msa_transition = Transition(dim=msa_s, hidden=msa_s * 4)
+ self.pair_weighted_averaging = PairWeightedAveraging(
+ c_m=msa_s,
+ c_z=token_z,
+ c_h=32,
+ num_heads=8,
+ )
+
+ self.pairformer_layer = PairformerNoSeqLayer(
+ token_z=token_z,
+ dropout=z_dropout,
+ pairwise_head_width=pairwise_head_width,
+ pairwise_num_heads=pairwise_num_heads,
+ )
+ self.outer_product_mean = OuterProductMean(
+ c_in=msa_s,
+ c_hidden=32,
+ c_out=token_z,
+ )
+
+ def forward(
+ self,
+ z: Tensor,
+ m: Tensor,
+ token_mask: Tensor,
+ msa_mask: Tensor,
+ chunk_heads_pwa: bool = False,
+ chunk_size_transition_z: int = None,
+ chunk_size_transition_msa: int = None,
+ chunk_size_outer_product: int = None,
+ chunk_size_tri_attn: int = None,
+ use_kernels: bool = False,
+ ) -> tuple[Tensor, Tensor]:
+ """Perform the forward pass.
+
+ Parameters
+ ----------
+ z : Tensor
+ The pairwise embeddings
+ emb : Tensor
+ The input embeddings
+ feats : dict[str, Tensor]
+ Input features
+
+ Returns
+ -------
+ Tensor
+ The output pairwise embeddings.
+
+ """
+ # Communication to MSA stack
+ msa_dropout = get_dropout_mask(self.msa_dropout, m, self.training)
+ m = m + msa_dropout * self.pair_weighted_averaging(
+ m, z, token_mask, chunk_heads_pwa
+ )
+ m = m + self.msa_transition(m, chunk_size_transition_msa)
+
+ z = z + self.outer_product_mean(m, msa_mask, chunk_size_outer_product)
+
+ # Compute pairwise stack
+ z = self.pairformer_layer(
+ z, token_mask, chunk_size_tri_attn, use_kernels=use_kernels
+ )
+
+ return z, m
+
+
+class BFactorModule(nn.Module):
+ """BFactor Module."""
+
+ def __init__(self, token_s: int, num_bins: int) -> None:
+ """Initialize the bfactor module.
+
+ Parameters
+ ----------
+ token_s : int
+ The token embedding size.
+
+ """
+ super().__init__()
+ self.bfactor = nn.Linear(token_s, num_bins)
+ self.num_bins = num_bins
+
+ def forward(self, s: Tensor) -> Tensor:
+ """Perform the forward pass.
+
+ Parameters
+ ----------
+ s : Tensor
+ The sequence embeddings
+
+ Returns
+ -------
+ Tensor
+ The predicted bfactor histogram.
+
+ """
+ return self.bfactor(s)
+
+
+class DistogramModule(nn.Module):
+ """Distogram Module."""
+
+ def __init__(self, token_z: int, num_bins: int, num_distograms: int = 1) -> None:
+ """Initialize the distogram module.
+
+ Parameters
+ ----------
+ token_z : int
+ The token pairwise embedding size.
+
+ """
+ super().__init__()
+ self.distogram = nn.Linear(token_z, num_distograms * num_bins)
+ self.num_distograms = num_distograms
+ self.num_bins = num_bins
+
+ def forward(self, z: Tensor) -> Tensor:
+ """Perform the forward pass.
+
+ Parameters
+ ----------
+ z : Tensor
+ The pairwise embeddings
+
+ Returns
+ -------
+ Tensor
+ The predicted distogram.
+
+ """
+ z = z + z.transpose(1, 2)
+ return self.distogram(z).reshape(
+ z.shape[0], z.shape[1], z.shape[2], self.num_distograms, self.num_bins
+ )
diff --git a/forks/boltz/src/boltz/model/modules/utils.py b/forks/boltz/src/boltz/model/modules/utils.py
new file mode 100644
index 00000000..a5a1f2e2
--- /dev/null
+++ b/forks/boltz/src/boltz/model/modules/utils.py
@@ -0,0 +1,303 @@
+# started from code from https://github.com/lucidrains/alphafold3-pytorch, MIT License, Copyright (c) 2024 Phil Wang
+
+from functools import partial
+from typing import Optional
+
+import torch
+import torch.nn.functional as F
+from torch.nn import (
+ Linear,
+ Module,
+)
+from torch.types import Device
+
+LinearNoBias = partial(Linear, bias=False)
+
+
+def exists(v):
+ return v is not None
+
+
+def default(v, d):
+ return v if exists(v) else d
+
+
+def log(t, eps=1e-20):
+ return torch.log(t.clamp(min=eps))
+
+
+class SwiGLU(Module):
+ def forward(
+ self,
+ x, #: Float['... d']
+ ): # -> Float[' ... (d//2)']:
+ x, gates = x.chunk(2, dim=-1)
+ return F.silu(gates) * x
+
+
+def center(atom_coords, atom_mask):
+ atom_mean = torch.sum(
+ atom_coords * atom_mask[:, :, None], dim=1, keepdim=True
+ ) / torch.sum(atom_mask[:, :, None], dim=1, keepdim=True)
+ atom_coords = atom_coords - atom_mean
+ return atom_coords
+
+
+def compute_random_augmentation(
+ multiplicity, s_trans=1.0, device=None, dtype=torch.float32
+):
+ R = random_rotations(multiplicity, dtype=dtype, device=device)
+ random_trans = (
+ torch.randn((multiplicity, 1, 3), dtype=dtype, device=device) * s_trans
+ )
+ return R, random_trans
+
+
+def randomly_rotate(coords, return_second_coords=False, second_coords=None):
+ R = random_rotations(len(coords), coords.dtype, coords.device)
+
+ if return_second_coords:
+ return torch.einsum("bmd,bds->bms", coords, R), torch.einsum(
+ "bmd,bds->bms", second_coords, R
+ ) if second_coords is not None else None
+
+ return torch.einsum("bmd,bds->bms", coords, R)
+
+
+def center_random_augmentation(
+ atom_coords,
+ atom_mask,
+ s_trans=1.0,
+ augmentation=True,
+ centering=True,
+ return_second_coords=False,
+ second_coords=None,
+):
+ """Algorithm 19"""
+ if centering:
+ atom_mean = torch.sum(
+ atom_coords * atom_mask[:, :, None], dim=1, keepdim=True
+ ) / torch.sum(atom_mask[:, :, None], dim=1, keepdim=True)
+ atom_coords = atom_coords - atom_mean
+
+ if second_coords is not None:
+ # apply same transformation also to this input
+ second_coords = second_coords - atom_mean
+
+ if augmentation:
+ atom_coords, second_coords = randomly_rotate(
+ atom_coords, return_second_coords=True, second_coords=second_coords
+ )
+ random_trans = torch.randn_like(atom_coords[:, 0:1, :]) * s_trans
+ atom_coords = atom_coords + random_trans
+
+ if second_coords is not None:
+ second_coords = second_coords + random_trans
+
+ if return_second_coords:
+ return atom_coords, second_coords
+
+ return atom_coords
+
+
+class ExponentialMovingAverage:
+ """from https://github.com/yang-song/score_sde_pytorch/blob/main/models/ema.py, Apache-2.0 license
+ Maintains (exponential) moving average of a set of parameters."""
+
+ def __init__(self, parameters, decay, use_num_updates=True):
+ """
+ Args:
+ parameters: Iterable of `torch.nn.Parameter`; usually the result of
+ `model.parameters()`.
+ decay: The exponential decay.
+ use_num_updates: Whether to use number of updates when computing
+ averages.
+ """
+ if decay < 0.0 or decay > 1.0:
+ raise ValueError("Decay must be between 0 and 1")
+ self.decay = decay
+ self.num_updates = 0 if use_num_updates else None
+ self.shadow_params = [p.clone().detach() for p in parameters if p.requires_grad]
+ self.collected_params = []
+
+ def update(self, parameters):
+ """
+ Update currently maintained parameters.
+ Call this every time the parameters are updated, such as the result of
+ the `optimizer.step()` call.
+ Args:
+ parameters: Iterable of `torch.nn.Parameter`; usually the same set of
+ parameters used to initialize this object.
+ """
+ decay = self.decay
+ if self.num_updates is not None:
+ self.num_updates += 1
+ decay = min(decay, (1 + self.num_updates) / (10 + self.num_updates))
+ one_minus_decay = 1.0 - decay
+ with torch.no_grad():
+ parameters = [p for p in parameters if p.requires_grad]
+ for s_param, param in zip(self.shadow_params, parameters):
+ s_param.sub_(one_minus_decay * (s_param - param))
+
+ def compatible(self, parameters):
+ if len(self.shadow_params) != len(parameters):
+ print(
+ f"Model has {len(self.shadow_params)} parameter tensors, the incoming ema {len(parameters)}"
+ )
+ return False
+
+ for s_param, param in zip(self.shadow_params, parameters):
+ if param.data.shape != s_param.data.shape:
+ print(
+ f"Model has parameter tensor of shape {s_param.data.shape} , the incoming ema {param.data.shape}"
+ )
+ return False
+ return True
+
+ def copy_to(self, parameters):
+ """
+ Copy current parameters into given collection of parameters.
+ Args:
+ parameters: Iterable of `torch.nn.Parameter`; the parameters to be
+ updated with the stored moving averages.
+ """
+ parameters = [p for p in parameters if p.requires_grad]
+ for s_param, param in zip(self.shadow_params, parameters):
+ if param.requires_grad:
+ param.data.copy_(s_param.data)
+
+ def store(self, parameters):
+ """
+ Save the current parameters for restoring later.
+ Args:
+ parameters: Iterable of `torch.nn.Parameter`; the parameters to be
+ temporarily stored.
+ """
+ self.collected_params = [param.clone() for param in parameters]
+
+ def restore(self, parameters):
+ """
+ Restore the parameters stored with the `store` method.
+ Useful to validate the model with EMA parameters without affecting the
+ original optimization process. Store the parameters before the
+ `copy_to` method. After validation (or model saving), use this to
+ restore the former parameters.
+ Args:
+ parameters: Iterable of `torch.nn.Parameter`; the parameters to be
+ updated with the stored parameters.
+ """
+ for c_param, param in zip(self.collected_params, parameters):
+ param.data.copy_(c_param.data)
+
+ def state_dict(self):
+ return dict(
+ decay=self.decay,
+ num_updates=self.num_updates,
+ shadow_params=self.shadow_params,
+ )
+
+ def load_state_dict(self, state_dict, device):
+ self.decay = state_dict["decay"]
+ self.num_updates = state_dict["num_updates"]
+ self.shadow_params = [
+ tensor.to(device) for tensor in state_dict["shadow_params"]
+ ]
+
+ def to(self, device):
+ self.shadow_params = [tensor.to(device) for tensor in self.shadow_params]
+
+
+# the following is copied from Torch3D, BSD License, Copyright (c) Meta Platforms, Inc. and affiliates.
+
+
+def _copysign(a: torch.Tensor, b: torch.Tensor) -> torch.Tensor:
+ """
+ Return a tensor where each element has the absolute value taken from the,
+ corresponding element of a, with sign taken from the corresponding
+ element of b. This is like the standard copysign floating-point operation,
+ but is not careful about negative 0 and NaN.
+
+ Args:
+ a: source tensor.
+ b: tensor whose signs will be used, of the same shape as a.
+
+ Returns:
+ Tensor of the same shape as a with the signs of b.
+ """
+ signs_differ = (a < 0) != (b < 0)
+ return torch.where(signs_differ, -a, a)
+
+
+def quaternion_to_matrix(quaternions: torch.Tensor) -> torch.Tensor:
+ """
+ Convert rotations given as quaternions to rotation matrices.
+
+ Args:
+ quaternions: quaternions with real part first,
+ as tensor of shape (..., 4).
+
+ Returns:
+ Rotation matrices as tensor of shape (..., 3, 3).
+ """
+ r, i, j, k = torch.unbind(quaternions, -1)
+ # pyre-fixme[58]: `/` is not supported for operand types `float` and `Tensor`.
+ two_s = 2.0 / (quaternions * quaternions).sum(-1)
+
+ o = torch.stack(
+ (
+ 1 - two_s * (j * j + k * k),
+ two_s * (i * j - k * r),
+ two_s * (i * k + j * r),
+ two_s * (i * j + k * r),
+ 1 - two_s * (i * i + k * k),
+ two_s * (j * k - i * r),
+ two_s * (i * k - j * r),
+ two_s * (j * k + i * r),
+ 1 - two_s * (i * i + j * j),
+ ),
+ -1,
+ )
+ return o.reshape(quaternions.shape[:-1] + (3, 3))
+
+
+def random_quaternions(
+ n: int, dtype: Optional[torch.dtype] = None, device: Optional[Device] = None
+) -> torch.Tensor:
+ """
+ Generate random quaternions representing rotations,
+ i.e. versors with nonnegative real part.
+
+ Args:
+ n: Number of quaternions in a batch to return.
+ dtype: Type to return.
+ device: Desired device of returned tensor. Default:
+ uses the current device for the default tensor type.
+
+ Returns:
+ Quaternions as tensor of shape (N, 4).
+ """
+ if isinstance(device, str):
+ device = torch.device(device)
+ o = torch.randn((n, 4), dtype=dtype, device=device)
+ s = (o * o).sum(1)
+ o = o / _copysign(torch.sqrt(s), o[:, 0])[:, None]
+ return o
+
+
+def random_rotations(
+ n: int, dtype: Optional[torch.dtype] = None, device: Optional[Device] = None
+) -> torch.Tensor:
+ """
+ Generate random rotations as 3x3 rotation matrices.
+
+ Args:
+ n: Number of rotation matrices in a batch to return.
+ dtype: Type to return.
+ device: Device of returned tensor. Default: if None,
+ uses the current device for the default tensor type.
+
+ Returns:
+ Rotation matrices as tensor of shape (n, 3, 3).
+ """
+ quaternions = random_quaternions(n, dtype=dtype, device=device)
+ return quaternion_to_matrix(quaternions)
diff --git a/forks/boltz/src/boltz/model/optim/__init__.py b/forks/boltz/src/boltz/model/optim/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/model/optim/ema.py b/forks/boltz/src/boltz/model/optim/ema.py
new file mode 100644
index 00000000..c50ec7f8
--- /dev/null
+++ b/forks/boltz/src/boltz/model/optim/ema.py
@@ -0,0 +1,389 @@
+# --------------------------------------------------------------------------------------
+# Modified from Bio-Diffusion (https://github.com/BioinfoMachineLearning/bio-diffusion):
+# Modified from : https://github.com/BioinfoMachineLearning/bio-diffusion/blob/main/src/utils/__init__.py
+# --------------------------------------------------------------------------------------
+
+from typing import Any, Optional
+
+import torch
+from pytorch_lightning import Callback, LightningModule, Trainer
+from pytorch_lightning.utilities.exceptions import MisconfigurationException
+from pytorch_lightning.utilities.types import STEP_OUTPUT
+
+
+class EMA(Callback):
+ """Implements Exponential Moving Averaging (EMA).
+
+ When training a model, this callback maintains moving averages
+ of the trained parameters. When evaluating, we use the moving
+ averages copy of the trained parameters. When saving, we save
+ an additional set of parameters with the prefix `ema`.
+
+ Adapted from:
+ https://github.com/NVIDIA/NeMo/blob/main/nemo/collections/common/callbacks/ema.py
+ https://github.com/BioinfoMachineLearning/bio-diffusion/blob/main/src/utils/__init__.py
+
+ """
+
+ def __init__(
+ self,
+ decay: float = 0.999,
+ apply_ema_every_n_steps: int = 1,
+ start_step: int = 0,
+ eval_with_ema: bool = True,
+ warm_start: bool = True,
+ ) -> None:
+ """Initialize the EMA callback.
+
+ Parameters
+ ----------
+ decay: float
+ The exponential decay, has to be between 0-1.
+ apply_ema_every_n_steps: int, optional (default=1)
+ Apply EMA every n global steps.
+ start_step: int, optional (default=0)
+ Start applying EMA from ``start_step`` global step onwards.
+ eval_with_ema: bool, optional (default=True)
+ Validate the EMA weights instead of the original weights.
+ Note this means that when saving the model, the
+ validation metrics are calculated with the EMA weights.
+
+ """
+ if not (0 <= decay <= 1):
+ msg = "EMA decay value must be between 0 and 1"
+ raise MisconfigurationException(msg)
+
+ self._ema_weights: Optional[dict[str, torch.Tensor]] = None
+ self._cur_step: Optional[int] = None
+ self._weights_buffer: Optional[dict[str, torch.Tensor]] = None
+ self.apply_ema_every_n_steps = apply_ema_every_n_steps
+ self.start_step = start_step
+ self.eval_with_ema = eval_with_ema
+ self.decay = decay
+ self.warm_start = warm_start
+
+ @property
+ def ema_initialized(self) -> bool:
+ """Check if EMA weights have been initialized.
+
+ Returns
+ -------
+ bool
+ Whether the EMA weights have been initialized.
+
+ """
+ return self._ema_weights is not None
+
+ def state_dict(self) -> dict[str, Any]:
+ """Return the current state of the callback.
+
+ Returns
+ -------
+ dict[str, Any]
+ The current state of the callback.
+
+ """
+ return {
+ "cur_step": self._cur_step,
+ "ema_weights": self._ema_weights,
+ }
+
+ def load_state_dict(self, state_dict: dict[str, Any]) -> None:
+ """Load the state of the callback.
+
+ Parameters
+ ----------
+ state_dict: dict[str, Any]
+ The state of the callback to load.
+
+ """
+ self._cur_step = state_dict["cur_step"]
+ self._ema_weights = state_dict["ema_weights"]
+
+ def should_apply_ema(self, step: int) -> bool:
+ """Check if EMA should be applied at the current step.
+
+ Parameters
+ ----------
+ step: int
+ The current global step.
+
+ Returns
+ -------
+ bool
+ True if EMA should be applied, False otherwise.
+
+ """
+ return (
+ step != self._cur_step
+ and step >= self.start_step
+ and step % self.apply_ema_every_n_steps == 0
+ )
+
+ def apply_ema(self, pl_module: LightningModule) -> None:
+ """Apply EMA to the model weights.
+
+ Parameters
+ ----------
+ pl_module: LightningModule
+ The LightningModule instance.
+
+ """
+ decay = self.decay
+ if self.warm_start:
+ decay = min(decay, (1 + self._cur_step) / (10 + self._cur_step))
+
+ for k, orig_weight in pl_module.state_dict().items():
+ ema_weight = self._ema_weights[k]
+ if (
+ ema_weight.data.dtype != torch.long # noqa: PLR1714
+ and orig_weight.data.dtype != torch.long # skip non-trainable weights
+ ):
+ diff = ema_weight.data - orig_weight.data
+ diff.mul_(1.0 - decay)
+ ema_weight.sub_(diff)
+
+ def on_load_checkpoint(
+ self,
+ trainer: Trainer,
+ pl_module: LightningModule, # noqa: ARG002
+ checkpoint: dict[str, Any],
+ ) -> None:
+ """Load the EMA weights from the checkpoint.
+
+ Parameters
+ ----------
+ trainer: Trainer
+ The Trainer instance.
+ pl_module: LightningModule
+ The LightningModule instance.
+ checkpoint: dict[str, Any]
+ The checkpoint to load.
+
+ """
+ if "ema" in checkpoint:
+ print("LOADING CHECKPOINT RUNNING")
+ self.load_state_dict(checkpoint["ema"])
+
+ def on_save_checkpoint(
+ self,
+ trainer: Trainer, # noqa: ARG002
+ pl_module: LightningModule, # noqa: ARG002
+ checkpoint: dict[str, Any],
+ ) -> None:
+ """Save the EMA weights to the checkpoint.
+
+ Parameters
+ ----------
+ trainer: Trainer
+ The Trainer instance.
+ pl_module: LightningModule
+ The LightningModule instance.
+ checkpoint: dict[str, Any]
+ The checkpoint to save.
+
+ """
+ if self.ema_initialized:
+ checkpoint["ema"] = self.state_dict()
+
+ def on_train_start(self, trainer: Trainer, pl_module: LightningModule) -> None: # noqa: ARG002
+ """Initialize EMA weights and move to device.
+
+ Parameters
+ ----------
+ trainer: pl.Trainer
+ The Trainer instance.
+ pl_module: pl.LightningModule
+ The LightningModule instance.
+
+ """
+ # Create EMA weights if not already initialized
+ if not self.ema_initialized:
+ self._ema_weights = {
+ k: p.detach().clone() for k, p in pl_module.state_dict().items()
+ }
+
+ # Move EMA weights to the correct device
+ self._ema_weights = {
+ k: p.to(pl_module.device) for k, p in self._ema_weights.items()
+ }
+
+ def on_train_batch_end(
+ self,
+ trainer: Trainer,
+ pl_module: LightningModule,
+ outputs: STEP_OUTPUT, # noqa: ARG002
+ batch: Any, # noqa: ARG002
+ batch_idx: int, # noqa: ARG002
+ ) -> None:
+ """Apply EMA to the model weights at the end of each training batch.
+
+ Parameters
+ ----------
+ trainer: Trainer
+ The Trainer instance.
+ pl_module: LightningModule
+ The LightningModule instance.
+ outputs: STEP_OUTPUT
+ The outputs of the model.
+ batch: Any
+ The current batch.
+ batch_idx: int
+ The index of the current batch.
+
+ """
+ if self.should_apply_ema(trainer.global_step):
+ self._cur_step = trainer.global_step
+ self.apply_ema(pl_module)
+
+ def replace_model_weights(self, pl_module: LightningModule) -> None:
+ """Replace model weights with EMA weights.
+
+ Parameters
+ ----------
+ pl_module: LightningModule
+ The LightningModule instance.
+
+ """
+ self._weights_buffer = {
+ k: p.detach().clone().to("cpu") for k, p in pl_module.state_dict().items()
+ }
+ pl_module.load_state_dict(self._ema_weights, strict=False)
+
+ def restore_original_weights(self, pl_module: LightningModule) -> None:
+ """Restore model weights to original weights.
+
+ Parameters
+ ----------
+ pl_module: LightningModule
+ The LightningModule instance.
+
+ """
+ pl_module.load_state_dict(self._weights_buffer, strict=False)
+ del self._weights_buffer
+
+ def _on_eval_start(self, pl_module: LightningModule) -> None:
+ """Use EMA weights for evaluation.
+
+ Parameters
+ ----------
+ pl_module: LightningModule
+ The LightningModule instance.
+
+ """
+ if self.ema_initialized and self.eval_with_ema:
+ self.replace_model_weights(pl_module)
+
+ def _on_eval_end(self, pl_module: LightningModule) -> None:
+ """Restore original weights after evaluation.
+
+ Parameters
+ ----------
+ pl_module: LightningModule
+ The LightningModule instance.
+
+ """
+ if self.ema_initialized and self.eval_with_ema:
+ self.restore_original_weights(pl_module)
+
+ def on_validation_start(
+ self,
+ trainer: Trainer, # noqa: ARG002
+ pl_module: LightningModule,
+ ) -> None:
+ """Use EMA weights for validation.
+
+ Parameters
+ ----------
+ trainer: Trainer
+ The Trainer instance.
+ pl_module: LightningModule
+ The LightningModule instance.
+
+ """
+ self._on_eval_start(pl_module)
+
+ def on_validation_end(
+ self,
+ trainer: Trainer, # noqa: ARG002
+ pl_module: LightningModule,
+ ) -> None:
+ """Restore original weights after validation.
+
+ Parameters
+ ----------
+ trainer: Trainer
+ The Trainer instance.
+ pl_module: LightningModule
+ The LightningModule instance.
+
+ """
+ self._on_eval_end(pl_module)
+
+ def on_test_start(
+ self,
+ trainer: Trainer, # noqa: ARG002
+ pl_module: LightningModule,
+ ) -> None:
+ """Use EMA weights for testing.
+
+ Parameters
+ ----------
+ trainer: Trainer
+ The Trainer instance.
+ pl_module: LightningModule
+ The LightningModule instance.
+
+ """
+ self._on_eval_start(pl_module)
+
+ def on_test_end(
+ self,
+ trainer: Trainer, # noqa: ARG002
+ pl_module: LightningModule,
+ ) -> None:
+ """Restore original weights after testing.
+
+ Parameters
+ ----------
+ trainer: Trainer
+ The Trainer instance.
+ pl_module: LightningModule
+ The LightningModule instance.
+
+ """
+ self._on_eval_end(pl_module)
+
+ def on_predict_start(
+ self,
+ trainer: Trainer, # noqa: ARG002
+ pl_module: LightningModule,
+ ) -> None:
+ """Use EMA weights for prediction.
+
+ Parameters
+ ----------
+ trainer: Trainer
+ The Trainer instance.
+ pl_module: LightningModule
+ The LightningModule instance.
+
+ """
+ self._on_eval_start(pl_module)
+
+ def on_predict_end(
+ self,
+ trainer: Trainer, # noqa: ARG002
+ pl_module: LightningModule,
+ ) -> None:
+ """Restore original weights after prediction.
+
+ Parameters
+ ----------
+ trainer: Trainer
+ The Trainer instance.
+ pl_module: LightningModule
+ The LightningModule instance.
+
+ """
+ self._on_eval_end(pl_module)
diff --git a/forks/boltz/src/boltz/model/optim/scheduler.py b/forks/boltz/src/boltz/model/optim/scheduler.py
new file mode 100644
index 00000000..bdc86ef4
--- /dev/null
+++ b/forks/boltz/src/boltz/model/optim/scheduler.py
@@ -0,0 +1,99 @@
+import torch
+
+
+class AlphaFoldLRScheduler(torch.optim.lr_scheduler._LRScheduler):
+ """Implements the learning rate schedule defined AF3.
+
+ A linear warmup is followed by a plateau at the maximum
+ learning rate and then exponential decay. Note that the
+ initial learning rate of the optimizer in question is
+ ignored; use this class' base_lr parameter to specify
+ the starting point of the warmup.
+
+ """
+
+ def __init__(
+ self,
+ optimizer: torch.optim.Optimizer,
+ last_epoch: int = -1,
+ base_lr: float = 0.0,
+ max_lr: float = 1.8e-3,
+ warmup_no_steps: int = 1000,
+ start_decay_after_n_steps: int = 50000,
+ decay_every_n_steps: int = 50000,
+ decay_factor: float = 0.95,
+ ) -> None:
+ """Initialize the learning rate scheduler.
+
+ Parameters
+ ----------
+ optimizer : torch.optim.Optimizer
+ The optimizer.
+ last_epoch : int, optional
+ The last epoch, by default -1
+ base_lr : float, optional
+ The base learning rate, by default 0.0
+ max_lr : float, optional
+ The maximum learning rate, by default 1.8e-3
+ warmup_no_steps : int, optional
+ The number of warmup steps, by default 1000
+ start_decay_after_n_steps : int, optional
+ The number of steps after which to start decay, by default 50000
+ decay_every_n_steps : int, optional
+ The number of steps after which to decay, by default 50000
+ decay_factor : float, optional
+ The decay factor, by default 0.95
+
+ """
+ step_counts = {
+ "warmup_no_steps": warmup_no_steps,
+ "start_decay_after_n_steps": start_decay_after_n_steps,
+ }
+
+ for k, v in step_counts.items():
+ if v < 0:
+ msg = f"{k} must be nonnegative"
+ raise ValueError(msg)
+
+ if warmup_no_steps > start_decay_after_n_steps:
+ msg = "warmup_no_steps must not exceed start_decay_after_n_steps"
+ raise ValueError(msg)
+
+ self.optimizer = optimizer
+ self.last_epoch = last_epoch
+ self.base_lr = base_lr
+ self.max_lr = max_lr
+ self.warmup_no_steps = warmup_no_steps
+ self.start_decay_after_n_steps = start_decay_after_n_steps
+ self.decay_every_n_steps = decay_every_n_steps
+ self.decay_factor = decay_factor
+
+ super().__init__(optimizer, last_epoch=last_epoch)
+
+ def state_dict(self) -> dict:
+ state_dict = {k: v for k, v in self.__dict__.items() if k not in ["optimizer"]}
+ return state_dict
+
+ def load_state_dict(self, state_dict):
+ self.__dict__.update(state_dict)
+
+ def get_lr(self):
+ if not self._get_lr_called_within_step:
+ msg = (
+ "To get the last learning rate computed by the scheduler, use "
+ "get_last_lr()"
+ )
+ raise RuntimeError(msg)
+
+ step_no = self.last_epoch
+
+ if step_no <= self.warmup_no_steps:
+ lr = self.base_lr + (step_no / self.warmup_no_steps) * self.max_lr
+ elif step_no > self.start_decay_after_n_steps:
+ steps_since_decay = step_no - self.start_decay_after_n_steps
+ exp = (steps_since_decay // self.decay_every_n_steps) + 1
+ lr = self.max_lr * (self.decay_factor**exp)
+ else: # plateau
+ lr = self.max_lr
+
+ return [lr for group in self.optimizer.param_groups]
diff --git a/forks/boltz/src/boltz/model/potentials/__init__.py b/forks/boltz/src/boltz/model/potentials/__init__.py
new file mode 100644
index 00000000..e69de29b
diff --git a/forks/boltz/src/boltz/model/potentials/potentials.py b/forks/boltz/src/boltz/model/potentials/potentials.py
new file mode 100644
index 00000000..95ea95ca
--- /dev/null
+++ b/forks/boltz/src/boltz/model/potentials/potentials.py
@@ -0,0 +1,772 @@
+from abc import ABC, abstractmethod
+from typing import Optional, Dict, Any, Set, List, Union
+
+import torch
+import numpy as np
+from boltz.data import const
+from boltz.model.potentials.schedules import (
+ ParameterSchedule,
+ ExponentialInterpolation,
+ PiecewiseStepFunction,
+)
+from boltz.model.loss.diffusionv2 import weighted_rigid_align
+
+
+class Potential(ABC):
+ def __init__(
+ self,
+ parameters: Optional[
+ Dict[str, Union[ParameterSchedule, float, int, bool]]
+ ] = None,
+ ):
+ self.parameters = parameters
+
+ def compute(self, coords, feats, parameters):
+ index, args, com_args, ref_args, operator_args = self.compute_args(
+ feats, parameters
+ )
+
+ if index.shape[1] == 0:
+ return torch.zeros(coords.shape[:-2], device=coords.device)
+
+ if com_args is not None:
+ com_index, atom_pad_mask = com_args
+ unpad_com_index = com_index[atom_pad_mask]
+ unpad_coords = coords[..., atom_pad_mask, :]
+ coords = torch.zeros(
+ (*unpad_coords.shape[:-2], unpad_com_index.max() + 1, 3),
+ device=coords.device,
+ ).scatter_reduce(
+ -2,
+ unpad_com_index.unsqueeze(-1).expand_as(unpad_coords),
+ unpad_coords,
+ "mean",
+ )
+ else:
+ com_index, atom_pad_mask = None, None
+
+ if ref_args is not None:
+ ref_coords, ref_mask, ref_atom_index, ref_token_index = ref_args
+ coords = coords[..., ref_atom_index, :]
+ else:
+ ref_coords, ref_mask, ref_atom_index, ref_token_index = (
+ None,
+ None,
+ None,
+ None,
+ )
+
+ if operator_args is not None:
+ negation_mask, union_index = operator_args
+ else:
+ negation_mask, union_index = None, None
+
+ value = self.compute_variable(
+ coords,
+ index,
+ ref_coords=ref_coords,
+ ref_mask=ref_mask,
+ compute_gradient=False,
+ )
+ energy = self.compute_function(
+ value, *args, negation_mask=negation_mask, compute_derivative=False
+ )
+
+ if union_index is not None:
+ neg_exp_energy = torch.exp(-1 * parameters["union_lambda"] * energy)
+ Z = torch.zeros(
+ (*energy.shape[:-1], union_index.max() + 1), device=union_index.device
+ ).scatter_reduce(
+ -1,
+ union_index.expand_as(neg_exp_energy),
+ neg_exp_energy,
+ "sum",
+ )
+ softmax_energy = neg_exp_energy / Z[..., union_index]
+ softmax_energy[Z[..., union_index] == 0] = 0
+ return (energy * softmax_energy).sum(dim=-1)
+
+ return energy.sum(dim=tuple(range(1, energy.dim())))
+
+ def compute_gradient(self, coords, feats, parameters):
+ index, args, com_args, ref_args, operator_args = self.compute_args(
+ feats, parameters
+ )
+ if index.shape[1] == 0:
+ return torch.zeros_like(coords)
+
+ if com_args is not None:
+ com_index, atom_pad_mask = com_args
+ unpad_coords = coords[..., atom_pad_mask, :]
+ unpad_com_index = com_index[atom_pad_mask]
+ coords = torch.zeros(
+ (*unpad_coords.shape[:-2], unpad_com_index.max() + 1, 3),
+ device=coords.device,
+ ).scatter_reduce(
+ -2,
+ unpad_com_index.unsqueeze(-1).expand_as(unpad_coords),
+ unpad_coords,
+ "mean",
+ )
+ com_counts = torch.bincount(com_index[atom_pad_mask])
+ else:
+ com_index, atom_pad_mask = None, None
+
+ if ref_args is not None:
+ ref_coords, ref_mask, ref_atom_index, ref_token_index = ref_args
+ coords = coords[..., ref_atom_index, :]
+ else:
+ ref_coords, ref_mask, ref_atom_index, ref_token_index = (
+ None,
+ None,
+ None,
+ None,
+ )
+
+ if operator_args is not None:
+ negation_mask, union_index = operator_args
+ else:
+ negation_mask, union_index = None, None
+
+ value, grad_value = self.compute_variable(
+ coords,
+ index,
+ ref_coords=ref_coords,
+ ref_mask=ref_mask,
+ compute_gradient=True,
+ )
+ energy, dEnergy = self.compute_function(
+ value, *args, negation_mask=negation_mask, compute_derivative=True
+ )
+ if union_index is not None:
+ neg_exp_energy = torch.exp(-1 * parameters["union_lambda"] * energy)
+ Z = torch.zeros(
+ (*energy.shape[:-1], union_index.max() + 1), device=union_index.device
+ ).scatter_reduce(
+ -1,
+ union_index.expand_as(energy),
+ neg_exp_energy,
+ "sum",
+ )
+ softmax_energy = neg_exp_energy / Z[..., union_index]
+ softmax_energy[Z[..., union_index] == 0] = 0
+ f = torch.zeros(
+ (*energy.shape[:-1], union_index.max() + 1), device=union_index.device
+ ).scatter_reduce(
+ -1,
+ union_index.expand_as(energy),
+ energy * softmax_energy,
+ "sum",
+ )
+ dSoftmax = (
+ dEnergy
+ * softmax_energy
+ * (1 + parameters["union_lambda"] * (energy - f[..., union_index]))
+ )
+ prod = dSoftmax.tile(grad_value.shape[-3]).unsqueeze(
+ -1
+ ) * grad_value.flatten(start_dim=-3, end_dim=-2)
+ if prod.dim() > 3:
+ prod = prod.sum(dim=list(range(1, prod.dim() - 2)))
+ grad_atom = torch.zeros_like(coords).scatter_reduce(
+ -2,
+ index.flatten(start_dim=0, end_dim=1)
+ .unsqueeze(-1)
+ .expand((*coords.shape[:-2], -1, 3)),
+ dSoftmax.tile(grad_value.shape[-3]).unsqueeze(-1)
+ * grad_value.flatten(start_dim=-3, end_dim=-2),
+ "sum",
+ )
+ else:
+ prod = dEnergy.tile(grad_value.shape[-3]).unsqueeze(
+ -1
+ ) * grad_value.flatten(start_dim=-3, end_dim=-2)
+ if prod.dim() > 3:
+ prod = prod.sum(dim=list(range(1, prod.dim() - 2)))
+ grad_atom = torch.zeros_like(coords).scatter_reduce(
+ -2,
+ index.flatten(start_dim=0, end_dim=1)
+ .unsqueeze(-1)
+ .expand((*coords.shape[:-2], -1, 3)), # 9 x 516 x 3
+ prod,
+ "sum",
+ )
+
+ if com_index is not None:
+ grad_atom = grad_atom[..., com_index, :]
+ elif ref_token_index is not None:
+ grad_atom = grad_atom[..., ref_token_index, :]
+
+ return grad_atom
+
+ def compute_parameters(self, t):
+ if self.parameters is None:
+ return None
+ parameters = {
+ name: parameter
+ if not isinstance(parameter, ParameterSchedule)
+ else parameter.compute(t)
+ for name, parameter in self.parameters.items()
+ }
+ return parameters
+
+ @abstractmethod
+ def compute_function(
+ self, value, *args, negation_mask=None, compute_derivative=False
+ ):
+ raise NotImplementedError
+
+ @abstractmethod
+ def compute_variable(self, coords, index, compute_gradient=False):
+ raise NotImplementedError
+
+ @abstractmethod
+ def compute_args(self, t, feats, **parameters):
+ raise NotImplementedError
+
+ def get_reference_coords(self, feats, parameters):
+ return None, None
+
+
+class FlatBottomPotential(Potential):
+ def compute_function(
+ self,
+ value,
+ k,
+ lower_bounds,
+ upper_bounds,
+ negation_mask=None,
+ compute_derivative=False,
+ ):
+ if lower_bounds is None:
+ lower_bounds = torch.full(value.shape[1:], float("-inf")).to(value)
+ if upper_bounds is None:
+ upper_bounds = torch.full(value.shape[1:], float("inf")).to(value)
+
+ if negation_mask is not None:
+ unbounded_below_mask = torch.isneginf(lower_bounds)
+ unbounded_above_mask = torch.isposinf(upper_bounds)
+ unbounded_mask = unbounded_below_mask + unbounded_above_mask
+ assert torch.all(unbounded_mask + negation_mask)
+ lower_bounds[~unbounded_above_mask * ~negation_mask] = upper_bounds[
+ ~unbounded_above_mask * ~negation_mask
+ ]
+ upper_bounds[~unbounded_above_mask * ~negation_mask] = float("inf")
+ upper_bounds[~unbounded_below_mask * ~negation_mask] = lower_bounds[
+ ~unbounded_below_mask * ~negation_mask
+ ]
+ lower_bounds[~unbounded_below_mask * ~negation_mask] = float("-inf")
+
+ neg_overflow_mask = value < lower_bounds
+ pos_overflow_mask = value > upper_bounds
+
+ energy = torch.zeros_like(value)
+ energy[neg_overflow_mask] = (k * (lower_bounds - value))[neg_overflow_mask]
+ energy[pos_overflow_mask] = (k * (value - upper_bounds))[pos_overflow_mask]
+ if not compute_derivative:
+ return energy
+
+ dEnergy = torch.zeros_like(value)
+ dEnergy[neg_overflow_mask] = (
+ -1 * k.expand_as(neg_overflow_mask)[neg_overflow_mask]
+ )
+ dEnergy[pos_overflow_mask] = (
+ 1 * k.expand_as(pos_overflow_mask)[pos_overflow_mask]
+ )
+
+ return energy, dEnergy
+
+
+class ReferencePotential(Potential):
+ def compute_variable(
+ self, coords, index, ref_coords, ref_mask, compute_gradient=False
+ ):
+ aligned_ref_coords = weighted_rigid_align(
+ ref_coords.float(),
+ coords[:, index].float(),
+ ref_mask,
+ ref_mask,
+ )
+
+ r = coords[:, index] - aligned_ref_coords
+ r_norm = torch.linalg.norm(r, dim=-1)
+
+ if not compute_gradient:
+ return r_norm
+
+ r_hat = r / r_norm.unsqueeze(-1)
+ grad = (r_hat * ref_mask.unsqueeze(-1)).unsqueeze(1)
+ return r_norm, grad
+
+
+class DistancePotential(Potential):
+ def compute_variable(
+ self, coords, index, ref_coords=None, ref_mask=None, compute_gradient=False
+ ):
+ r_ij = coords.index_select(-2, index[0]) - coords.index_select(-2, index[1])
+ r_ij_norm = torch.linalg.norm(r_ij, dim=-1)
+ r_hat_ij = r_ij / r_ij_norm.unsqueeze(-1)
+
+ if not compute_gradient:
+ return r_ij_norm
+
+ grad_i = r_hat_ij
+ grad_j = -1 * r_hat_ij
+ grad = torch.stack((grad_i, grad_j), dim=1)
+ return r_ij_norm, grad
+
+
+class DihedralPotential(Potential):
+ def compute_variable(
+ self, coords, index, ref_coords=None, ref_mask=None, compute_gradient=False
+ ):
+ r_ij = coords.index_select(-2, index[0]) - coords.index_select(-2, index[1])
+ r_kj = coords.index_select(-2, index[2]) - coords.index_select(-2, index[1])
+ r_kl = coords.index_select(-2, index[2]) - coords.index_select(-2, index[3])
+
+ n_ijk = torch.cross(r_ij, r_kj, dim=-1)
+ n_jkl = torch.cross(r_kj, r_kl, dim=-1)
+
+ r_kj_norm = torch.linalg.norm(r_kj, dim=-1)
+ n_ijk_norm = torch.linalg.norm(n_ijk, dim=-1)
+ n_jkl_norm = torch.linalg.norm(n_jkl, dim=-1)
+
+ sign_phi = torch.sign(
+ r_kj.unsqueeze(-2) @ torch.cross(n_ijk, n_jkl, dim=-1).unsqueeze(-1)
+ ).squeeze(-1, -2)
+ phi = sign_phi * torch.arccos(
+ torch.clamp(
+ (n_ijk.unsqueeze(-2) @ n_jkl.unsqueeze(-1)).squeeze(-1, -2)
+ / (n_ijk_norm * n_jkl_norm),
+ -1 + 1e-8,
+ 1 - 1e-8,
+ )
+ )
+
+ if not compute_gradient:
+ return phi
+
+ a = (
+ (r_ij.unsqueeze(-2) @ r_kj.unsqueeze(-1)).squeeze(-1, -2) / (r_kj_norm**2)
+ ).unsqueeze(-1)
+ b = (
+ (r_kl.unsqueeze(-2) @ r_kj.unsqueeze(-1)).squeeze(-1, -2) / (r_kj_norm**2)
+ ).unsqueeze(-1)
+
+ grad_i = n_ijk * (r_kj_norm / n_ijk_norm**2).unsqueeze(-1)
+ grad_l = -1 * n_jkl * (r_kj_norm / n_jkl_norm**2).unsqueeze(-1)
+ grad_j = (a - 1) * grad_i - b * grad_l
+ grad_k = (b - 1) * grad_l - a * grad_i
+ grad = torch.stack((grad_i, grad_j, grad_k, grad_l), dim=1)
+ return phi, grad
+
+
+class AbsDihedralPotential(DihedralPotential):
+ def compute_variable(
+ self, coords, index, ref_coords=None, ref_mask=None, compute_gradient=False
+ ):
+ if not compute_gradient:
+ phi = super().compute_variable(
+ coords, index, compute_gradient=compute_gradient
+ )
+ phi = torch.abs(phi)
+ return phi
+
+ phi, grad = super().compute_variable(
+ coords, index, compute_gradient=compute_gradient
+ )
+ grad[(phi < 0)[..., None, :, None].expand_as(grad)] *= -1
+ phi = torch.abs(phi)
+
+ return phi, grad
+
+
+class PoseBustersPotential(FlatBottomPotential, DistancePotential):
+ def compute_args(self, feats, parameters):
+ pair_index = feats["rdkit_bounds_index"][0]
+ lower_bounds = feats["rdkit_lower_bounds"][0].clone()
+ upper_bounds = feats["rdkit_upper_bounds"][0].clone()
+ bond_mask = feats["rdkit_bounds_bond_mask"][0]
+ angle_mask = feats["rdkit_bounds_angle_mask"][0]
+
+ lower_bounds[bond_mask * ~angle_mask] *= 1.0 - parameters["bond_buffer"]
+ upper_bounds[bond_mask * ~angle_mask] *= 1.0 + parameters["bond_buffer"]
+ lower_bounds[~bond_mask * angle_mask] *= 1.0 - parameters["angle_buffer"]
+ upper_bounds[~bond_mask * angle_mask] *= 1.0 + parameters["angle_buffer"]
+ lower_bounds[bond_mask * angle_mask] *= 1.0 - min(
+ parameters["bond_buffer"], parameters["angle_buffer"]
+ )
+ upper_bounds[bond_mask * angle_mask] *= 1.0 + min(
+ parameters["bond_buffer"], parameters["angle_buffer"]
+ )
+ lower_bounds[~bond_mask * ~angle_mask] *= 1.0 - parameters["clash_buffer"]
+ upper_bounds[~bond_mask * ~angle_mask] = float("inf")
+
+ k = torch.ones_like(lower_bounds)
+
+ return pair_index, (k, lower_bounds, upper_bounds), None, None, None
+
+
+class ConnectionsPotential(FlatBottomPotential, DistancePotential):
+ def compute_args(self, feats, parameters):
+ pair_index = feats["connected_atom_index"][0]
+ lower_bounds = None
+ upper_bounds = torch.full(
+ (pair_index.shape[1],), parameters["buffer"], device=pair_index.device
+ )
+ k = torch.ones_like(upper_bounds)
+
+ return pair_index, (k, lower_bounds, upper_bounds), None, None, None
+
+
+class VDWOverlapPotential(FlatBottomPotential, DistancePotential):
+ def compute_args(self, feats, parameters):
+ atom_chain_id = (
+ torch.bmm(
+ feats["atom_to_token"].float(), feats["asym_id"].unsqueeze(-1).float()
+ )
+ .squeeze(-1)
+ .long()
+ )[0]
+ atom_pad_mask = feats["atom_pad_mask"][0].bool()
+ chain_sizes = torch.bincount(atom_chain_id[atom_pad_mask])
+ single_ion_mask = (chain_sizes > 1)[atom_chain_id]
+
+ vdw_radii = torch.zeros(
+ const.num_elements, dtype=torch.float32, device=atom_chain_id.device
+ )
+ vdw_radii[1:119] = torch.tensor(
+ const.vdw_radii, dtype=torch.float32, device=atom_chain_id.device
+ )
+ atom_vdw_radii = (
+ feats["ref_element"].float() @ vdw_radii.unsqueeze(-1)
+ ).squeeze(-1)[0]
+
+ pair_index = torch.triu_indices(
+ atom_chain_id.shape[0],
+ atom_chain_id.shape[0],
+ 1,
+ device=atom_chain_id.device,
+ )
+
+ pair_pad_mask = atom_pad_mask[pair_index].all(dim=0)
+ pair_ion_mask = single_ion_mask[pair_index[0]] * single_ion_mask[pair_index[1]]
+
+ num_chains = atom_chain_id.max() + 1
+ connected_chain_index = feats["connected_chain_index"][0]
+ connected_chain_matrix = torch.eye(
+ num_chains, device=atom_chain_id.device, dtype=torch.bool
+ )
+ connected_chain_matrix[connected_chain_index[0], connected_chain_index[1]] = (
+ True
+ )
+ connected_chain_matrix[connected_chain_index[1], connected_chain_index[0]] = (
+ True
+ )
+ connected_chain_mask = connected_chain_matrix[
+ atom_chain_id[pair_index[0]], atom_chain_id[pair_index[1]]
+ ]
+
+ pair_index = pair_index[
+ :, pair_pad_mask * pair_ion_mask * ~connected_chain_mask
+ ]
+
+ lower_bounds = atom_vdw_radii[pair_index].sum(dim=0) * (
+ 1.0 - parameters["buffer"]
+ )
+ upper_bounds = None
+ k = torch.ones_like(lower_bounds)
+
+ return pair_index, (k, lower_bounds, upper_bounds), None, None, None
+
+
+class SymmetricChainCOMPotential(FlatBottomPotential, DistancePotential):
+ def compute_args(self, feats, parameters):
+ atom_chain_id = (
+ torch.bmm(
+ feats["atom_to_token"].float(), feats["asym_id"].unsqueeze(-1).float()
+ )
+ .squeeze(-1)
+ .long()
+ )[0]
+ atom_pad_mask = feats["atom_pad_mask"][0].bool()
+ chain_sizes = torch.bincount(atom_chain_id[atom_pad_mask])
+ single_ion_mask = chain_sizes > 1
+
+ pair_index = feats["symmetric_chain_index"][0]
+ pair_ion_mask = single_ion_mask[pair_index[0]] * single_ion_mask[pair_index[1]]
+ pair_index = pair_index[:, pair_ion_mask]
+ lower_bounds = torch.full(
+ (pair_index.shape[1],),
+ parameters["buffer"],
+ dtype=torch.float32,
+ device=pair_index.device,
+ )
+ upper_bounds = None
+ k = torch.ones_like(lower_bounds)
+
+ return (
+ pair_index,
+ (k, lower_bounds, upper_bounds),
+ (atom_chain_id, atom_pad_mask),
+ None,
+ None,
+ )
+
+
+class StereoBondPotential(FlatBottomPotential, AbsDihedralPotential):
+ def compute_args(self, feats, parameters):
+ stereo_bond_index = feats["stereo_bond_index"][0]
+ stereo_bond_orientations = feats["stereo_bond_orientations"][0].bool()
+
+ lower_bounds = torch.zeros(
+ stereo_bond_orientations.shape, device=stereo_bond_orientations.device
+ )
+ upper_bounds = torch.zeros(
+ stereo_bond_orientations.shape, device=stereo_bond_orientations.device
+ )
+ lower_bounds[stereo_bond_orientations] = torch.pi - parameters["buffer"]
+ upper_bounds[stereo_bond_orientations] = float("inf")
+ lower_bounds[~stereo_bond_orientations] = float("-inf")
+ upper_bounds[~stereo_bond_orientations] = parameters["buffer"]
+
+ k = torch.ones_like(lower_bounds)
+
+ return stereo_bond_index, (k, lower_bounds, upper_bounds), None, None, None
+
+
+class ChiralAtomPotential(FlatBottomPotential, DihedralPotential):
+ def compute_args(self, feats, parameters):
+ chiral_atom_index = feats["chiral_atom_index"][0]
+ chiral_atom_orientations = feats["chiral_atom_orientations"][0].bool()
+
+ lower_bounds = torch.zeros(
+ chiral_atom_orientations.shape, device=chiral_atom_orientations.device
+ )
+ upper_bounds = torch.zeros(
+ chiral_atom_orientations.shape, device=chiral_atom_orientations.device
+ )
+ lower_bounds[chiral_atom_orientations] = parameters["buffer"]
+ upper_bounds[chiral_atom_orientations] = float("inf")
+ upper_bounds[~chiral_atom_orientations] = -1 * parameters["buffer"]
+ lower_bounds[~chiral_atom_orientations] = float("-inf")
+
+ k = torch.ones_like(lower_bounds)
+ return chiral_atom_index, (k, lower_bounds, upper_bounds), None, None, None
+
+
+class PlanarBondPotential(FlatBottomPotential, AbsDihedralPotential):
+ def compute_args(self, feats, parameters):
+ double_bond_index = feats["planar_bond_index"][0].T
+ double_bond_improper_index = torch.tensor(
+ [
+ [1, 2, 3, 0],
+ [4, 5, 0, 3],
+ ],
+ device=double_bond_index.device,
+ ).T
+ improper_index = (
+ double_bond_index[:, double_bond_improper_index]
+ .swapaxes(0, 1)
+ .flatten(start_dim=1)
+ )
+ lower_bounds = None
+ upper_bounds = torch.full(
+ (improper_index.shape[1],),
+ parameters["buffer"],
+ device=improper_index.device,
+ )
+ k = torch.ones_like(upper_bounds)
+
+ return improper_index, (k, lower_bounds, upper_bounds), None, None, None
+
+
+class TemplateReferencePotential(FlatBottomPotential, ReferencePotential):
+ def compute_args(self, feats, parameters):
+ if "template_mask_cb" not in feats or "template_force" not in feats:
+ return torch.empty([1, 0]), None, None, None, None
+
+ template_mask = feats["template_mask_cb"][feats["template_force"]]
+ if template_mask.shape[0] == 0:
+ return torch.empty([1, 0]), None, None, None, None
+
+ ref_coords = feats["template_cb"][feats["template_force"]].clone()
+ ref_mask = feats["template_mask_cb"][feats["template_force"]].clone()
+ ref_atom_index = (
+ torch.bmm(
+ feats["token_to_rep_atom"].float(),
+ torch.arange(
+ feats["atom_pad_mask"].shape[1],
+ device=feats["atom_pad_mask"].device,
+ dtype=torch.float32,
+ )[None, :, None],
+ )
+ .squeeze(-1)
+ .long()
+ )[0]
+ ref_token_index = (
+ torch.bmm(
+ feats["atom_to_token"].float(),
+ feats["token_index"].unsqueeze(-1).float(),
+ )
+ .squeeze(-1)
+ .long()
+ )[0]
+
+ index = torch.arange(
+ template_mask.shape[-1], dtype=torch.long, device=template_mask.device
+ )[None]
+ upper_bounds = torch.full(
+ template_mask.shape, float("inf"), device=index.device, dtype=torch.float32
+ )
+ ref_idxs = torch.argwhere(template_mask).T
+ upper_bounds[ref_idxs.unbind()] = feats["template_force_threshold"][
+ feats["template_force"]
+ ][ref_idxs[0]]
+
+ lower_bounds = None
+ k = torch.ones_like(upper_bounds)
+ return (
+ index,
+ (k, lower_bounds, upper_bounds),
+ None,
+ (ref_coords, ref_mask, ref_atom_index, ref_token_index),
+ None,
+ )
+
+
+class ContactPotentital(FlatBottomPotential, DistancePotential):
+ def compute_args(self, feats, parameters):
+ index = feats["contact_pair_index"][0]
+ union_index = feats["contact_union_index"][0]
+ negation_mask = feats["contact_negation_mask"][0]
+ lower_bounds = None
+ upper_bounds = feats["contact_thresholds"][0].clone()
+ k = torch.ones_like(upper_bounds)
+ return (
+ index,
+ (k, lower_bounds, upper_bounds),
+ None,
+ None,
+ (negation_mask, union_index),
+ )
+
+
+def get_potentials(steering_args, boltz2=False):
+ potentials = []
+ if steering_args["fk_steering"] or steering_args["physical_guidance_update"]:
+ potentials.extend(
+ [
+ SymmetricChainCOMPotential(
+ parameters={
+ "guidance_interval": 4,
+ "guidance_weight": 0.5
+ if steering_args["contact_guidance_update"]
+ else 0.0,
+ "resampling_weight": 0.5,
+ "buffer": ExponentialInterpolation(
+ start=1.0, end=5.0, alpha=-2.0
+ ),
+ }
+ ),
+ VDWOverlapPotential(
+ parameters={
+ "guidance_interval": 5,
+ "guidance_weight": (
+ PiecewiseStepFunction(thresholds=[0.4], values=[0.125, 0.0])
+ if steering_args["contact_guidance_update"]
+ else 0.0
+ ),
+ "resampling_weight": PiecewiseStepFunction(
+ thresholds=[0.6], values=[0.01, 0.0]
+ ),
+ "buffer": 0.225,
+ }
+ ),
+ ConnectionsPotential(
+ parameters={
+ "guidance_interval": 1,
+ "guidance_weight": 0.15
+ if steering_args["contact_guidance_update"]
+ else 0.0,
+ "resampling_weight": 1.0,
+ "buffer": 2.0,
+ }
+ ),
+ PoseBustersPotential(
+ parameters={
+ "guidance_interval": 1,
+ "guidance_weight": 0.01
+ if steering_args["contact_guidance_update"]
+ else 0.0,
+ "resampling_weight": 0.1,
+ "bond_buffer": 0.2,
+ "angle_buffer": 0.2,
+ "clash_buffer": 0.15,
+ }
+ ),
+ ChiralAtomPotential(
+ parameters={
+ "guidance_interval": 1,
+ "guidance_weight": 0.1
+ if steering_args["contact_guidance_update"]
+ else 0.0,
+ "resampling_weight": 1.0,
+ "buffer": 0.52360,
+ }
+ ),
+ StereoBondPotential(
+ parameters={
+ "guidance_interval": 1,
+ "guidance_weight": 0.05
+ if steering_args["contact_guidance_update"]
+ else 0.0,
+ "resampling_weight": 1.0,
+ "buffer": 0.52360,
+ }
+ ),
+ PlanarBondPotential(
+ parameters={
+ "guidance_interval": 1,
+ "guidance_weight": 0.05
+ if steering_args["contact_guidance_update"]
+ else 0.0,
+ "resampling_weight": 1.0,
+ "buffer": 0.26180,
+ }
+ ),
+ ]
+ )
+ if boltz2 and (
+ steering_args["fk_steering"] or steering_args["contact_guidance_update"]
+ ):
+ potentials.extend(
+ [
+ ContactPotentital(
+ parameters={
+ "guidance_interval": 4,
+ "guidance_weight": (
+ PiecewiseStepFunction(
+ thresholds=[0.25, 0.75], values=[0.0, 0.5, 1.0]
+ )
+ if steering_args["contact_guidance_update"]
+ else 0.0
+ ),
+ "resampling_weight": 1.0,
+ "union_lambda": ExponentialInterpolation(
+ start=8.0, end=0.0, alpha=-2.0
+ ),
+ }
+ ),
+ TemplateReferencePotential(
+ parameters={
+ "guidance_interval": 2,
+ "guidance_weight": 0.1
+ if steering_args["contact_guidance_update"]
+ else 0.0,
+ "resampling_weight": 1.0,
+ }
+ ),
+ ]
+ )
+ return potentials
diff --git a/forks/boltz/src/boltz/model/potentials/schedules.py b/forks/boltz/src/boltz/model/potentials/schedules.py
new file mode 100644
index 00000000..564249aa
--- /dev/null
+++ b/forks/boltz/src/boltz/model/potentials/schedules.py
@@ -0,0 +1,37 @@
+import math
+from abc import ABC
+
+
+class ParameterSchedule(ABC):
+ def compute(self, t):
+ raise NotImplementedError
+
+
+class ExponentialInterpolation(ParameterSchedule):
+ def __init__(self, start, end, alpha):
+ self.start = start
+ self.end = end
+ self.alpha = alpha
+
+ def compute(self, t):
+ if self.alpha != 0:
+ return self.start + (self.end - self.start) * (
+ math.exp(self.alpha * t) - 1
+ ) / (math.exp(self.alpha) - 1)
+ else:
+ return self.start + (self.end - self.start) * t
+
+
+class PiecewiseStepFunction(ParameterSchedule):
+ def __init__(self, thresholds, values):
+ self.thresholds = thresholds
+ self.values = values
+
+ def compute(self, t):
+ assert len(self.thresholds) > 0
+ assert len(self.values) == len(self.thresholds) + 1
+
+ idx = 0
+ while idx < len(self.thresholds) and t > self.thresholds[idx]:
+ idx += 1
+ return self.values[idx]
diff --git a/forks/boltz/tests/model/layers/test_outer_product_mean.py b/forks/boltz/tests/model/layers/test_outer_product_mean.py
new file mode 100644
index 00000000..a9623e45
--- /dev/null
+++ b/forks/boltz/tests/model/layers/test_outer_product_mean.py
@@ -0,0 +1,38 @@
+import pytorch_lightning
+import torch
+import torch.nn as nn
+
+import unittest
+
+from boltz.model.layers.outer_product_mean import OuterProductMean
+
+
+class OuterProductMeanTest(unittest.TestCase):
+ def setUp(self):
+ self.c_in = 32
+ self.c_hidden = 16
+ self.c_out = 64
+
+ torch.set_grad_enabled(False)
+ pytorch_lightning.seed_everything(1100)
+ self.layer = OuterProductMean(self.c_in, self.c_hidden, self.c_out)
+
+ # Initialize layer
+ for name, param in self.layer.named_parameters():
+ nn.init.normal_(param, mean=1.0, std=1.0)
+
+ # Set to eval mode
+ self.layer.eval()
+
+ def test_chunk(self):
+ chunk_sizes = [16, 33, 64, 83, 100]
+ B, S, N = 1, 49, 84
+ m = torch.randn(size=(B, S, N, self.c_in))
+ mask = torch.randint(low=0, high=1, size=(B, S, N))
+
+ with torch.no_grad():
+ exp_output = self.layer(m=m, mask=mask)
+ for chunk_size in chunk_sizes:
+ with self.subTest(chunk_size=chunk_size):
+ act_output = self.layer(m=m, mask=mask, chunk_size=chunk_size)
+ assert torch.allclose(exp_output, act_output, atol=1e-8)
diff --git a/forks/boltz/tests/model/layers/test_triangle_attention.py b/forks/boltz/tests/model/layers/test_triangle_attention.py
new file mode 100644
index 00000000..e9fa5118
--- /dev/null
+++ b/forks/boltz/tests/model/layers/test_triangle_attention.py
@@ -0,0 +1,35 @@
+import pytorch_lightning
+import torch
+import torch.nn as nn
+
+import unittest
+
+from boltz.model.layers.triangular_attention.attention import TriangleAttention
+
+
+class OuterProductMeanTest(unittest.TestCase):
+ def setUp(self):
+ self.c_in = 128
+ self.c_hidden = 32
+ self.no_heads = 1
+
+ torch.set_grad_enabled(False)
+ pytorch_lightning.seed_everything(1100)
+ self.layer = TriangleAttention(self.c_in, self.c_hidden, self.no_heads)
+
+ # Initialize layer
+ for name, param in self.layer.named_parameters():
+ nn.init.normal_(param, mean=1.0, std=1.0)
+
+ def test_chunk(self):
+ chunk_sizes = [16, 33, 64, 100]
+ B, N = 1, 99
+ m = torch.randn(size=(B, N, N, self.c_in))
+ mask = torch.randint(low=0, high=1, size=(B, N, N))
+
+ with torch.no_grad():
+ exp_output = self.layer(x=m, mask=mask)
+ for chunk_size in chunk_sizes:
+ with self.subTest(chunk_size=chunk_size):
+ act_output = self.layer(x=m, mask=mask, chunk_size=chunk_size)
+ assert torch.allclose(exp_output, act_output, atol=1e-8)
diff --git a/forks/boltz/tests/profiling.py b/forks/boltz/tests/profiling.py
new file mode 100644
index 00000000..bd083318
--- /dev/null
+++ b/forks/boltz/tests/profiling.py
@@ -0,0 +1,67 @@
+import torch
+import gc
+
+
+def clear_gradients(*args):
+ for arg in args:
+ if isinstance(arg, torch.Tensor) and arg.grad is not None:
+ arg.grad = None
+
+
+def clear_memory(device):
+ torch._C._cuda_clearCublasWorkspaces()
+ torch._dynamo.reset()
+ gc.collect()
+ torch.cuda.empty_cache()
+ torch.cuda.reset_peak_memory_stats(device)
+
+
+def peak_memory(f, *args, device):
+ for _ in range(3):
+ # Clean everything
+ clear_memory(device)
+ clear_gradients(*args)
+
+ # Run once
+ f(*args)
+
+ # Measure peak memory
+ torch.cuda.synchronize()
+ memory = torch.cuda.max_memory_allocated(device)
+
+ return memory
+
+
+def current_memory(device):
+ return torch.cuda.memory_allocated(device) / (1024**3)
+
+
+def memory_measure(f, device, num_iters=3):
+ # Clean everything
+ clear_memory(device)
+
+ # Run measurement
+ print("Current memory: ", current_memory(device))
+ memory = peak_memory(f, device=device)
+
+ print("Peak memory: ", memory / (1024**3))
+ return memory / (1024**3)
+
+
+def memory_measure_simple(f, device, *args, **kwargs):
+ # Clean everything
+ clear_memory(device)
+ clear_gradients(*args)
+
+ current = current_memory(device)
+
+ # Run once
+ out = f(*args, **kwargs)
+
+ # Measure peak memory
+ torch.cuda.synchronize()
+ memory = torch.cuda.max_memory_allocated(device)
+ memory = memory / (1024**3)
+ memory = memory - current
+
+ return out, memory
diff --git a/forks/boltz/tests/test_kernels.py b/forks/boltz/tests/test_kernels.py
new file mode 100644
index 00000000..b43c0a99
--- /dev/null
+++ b/forks/boltz/tests/test_kernels.py
@@ -0,0 +1,288 @@
+import os
+import time
+
+import pandas as pd
+import torch
+import triton
+from profiling import clear_memory, current_memory, memory_measure
+
+from boltz.model.layers.pairformer import PairformerLayer
+
+# Disable auto-tuning
+os.environ["CUEQ_DEFAULT_CONFIG"] = "1"
+os.environ["CUEQ_DISABLE_AOT_TUNING"] = "1"
+
+# Set hyperparameters
+C_S = 384
+C_Z = 128
+BATCH_SIZE = 1
+INFERENCE = False
+SEQ_LEN = [128, 256, 384, 512, 768]
+PRECISION = torch.bfloat16
+COMPILE = False
+device = "cuda:0"
+torch.set_grad_enabled(not INFERENCE)
+
+# Preload modules
+model = PairformerLayer(C_S, C_Z, v2=True)
+model.cuda()
+if COMPILE:
+ model = torch.compile(model, fullgraph=True, dynamic=False)
+
+if INFERENCE:
+ model.eval()
+
+
+def fwd(
+ model,
+ s,
+ z,
+ mask,
+ pair_mask,
+ use_cuequiv_mul=False,
+ use_cuequiv_attn=False,
+):
+ model(
+ s,
+ z,
+ mask,
+ pair_mask,
+ use_cuequiv_mul=use_cuequiv_mul,
+ use_cuequiv_attn=use_cuequiv_attn,
+ )
+
+
+def backward(
+ model,
+ s,
+ z,
+ mask,
+ pair_mask,
+ use_cuequiv_mul=False,
+ use_cuequiv_attn=False,
+):
+ s, z = model(
+ s,
+ z,
+ mask,
+ pair_mask,
+ use_cuequiv_mul=use_cuequiv_mul,
+ use_cuequiv_attn=use_cuequiv_attn,
+ )
+ (s.sum() + z.sum()).backward()
+
+
+def speed(func, its=10, warmup=10):
+ for _ in range(warmup):
+ func()
+ torch.cuda.synchronize()
+ start = time.time()
+ for _ in range(its):
+ func()
+ torch.cuda.synchronize()
+ time_a = time.time() - start
+ time_a /= its
+ return time_a
+
+
+# Full model
+@triton.testing.perf_report(
+ triton.testing.Benchmark(
+ x_names=["size"],
+ x_vals=SEQ_LEN,
+ line_arg="provider", # Argument name whose value corresponds to a different line in the plot.
+ line_vals=[
+ "Default",
+ "TriAttn",
+ "Trimul",
+ "TriAttn+Trimul",
+ ], # Possible values for `line_arg`.
+ line_names=[
+ "Default",
+ "TriAttn",
+ "Trimul",
+ "TriAttn+Trimul",
+ ], # Label name for the lines.
+ plot_name="performance", # Name for the plot. Used also as a file name for saving the plot.
+ args={}, # Values for function arguments not in `x_names` and `y_name`.
+ )
+)
+def benchmark(size, provider):
+ clear_memory(device)
+
+ # Now run the benchmark
+ s = torch.randn(
+ (BATCH_SIZE, size, C_S),
+ device=device,
+ dtype=PRECISION,
+ requires_grad=False,
+ )
+ z = torch.randn(
+ (BATCH_SIZE, size, size, C_Z),
+ device=device,
+ dtype=PRECISION,
+ requires_grad=False,
+ )
+ mask = torch.ones(
+ (BATCH_SIZE, size),
+ device=device,
+ dtype=PRECISION,
+ requires_grad=False,
+ ).float()
+ pair_mask = torch.ones(
+ (BATCH_SIZE, size, size),
+ device=device,
+ dtype=PRECISION,
+ requires_grad=False,
+ ).float()
+
+ with torch.autocast("cuda", dtype=PRECISION):
+ fn = fwd if INFERENCE else backward
+ if provider == "Default":
+ ms = speed(
+ lambda: fn(
+ model,
+ s,
+ z,
+ mask,
+ pair_mask,
+ use_cuequiv_mul=False,
+ use_cuequiv_attn=False,
+ )
+ )
+ elif provider == "TriAttn":
+ ms = speed(
+ lambda: fn(
+ model,
+ s,
+ z,
+ mask,
+ pair_mask,
+ use_cuequiv_attn=True,
+ use_cuequiv_mul=False,
+ )
+ )
+ elif provider == "Trimul":
+ ms = speed(
+ lambda: fn(
+ model,
+ s,
+ z,
+ mask,
+ pair_mask,
+ use_cuequiv_attn=False,
+ use_cuequiv_mul=True,
+ )
+ )
+ elif provider == "TriAttn+Trimul":
+ ms = speed(
+ lambda: fn(
+ model,
+ s,
+ z,
+ mask,
+ pair_mask,
+ use_cuequiv_attn=True,
+ use_cuequiv_mul=True,
+ )
+ )
+
+ # Compute throughput in sequences per second
+ return ms / BATCH_SIZE
+
+
+print("Speed")
+benchmark.run(print_data=True, show_plots=False)
+
+start_mem = current_memory(device)
+
+df = []
+for size in SEQ_LEN:
+ print(size)
+ s = torch.randn(
+ (BATCH_SIZE, size, C_S),
+ device=device,
+ dtype=PRECISION,
+ requires_grad=False,
+ )
+ z = torch.randn(
+ (BATCH_SIZE, size, size, C_Z),
+ device=device,
+ dtype=PRECISION,
+ requires_grad=False,
+ )
+ mask = torch.ones(
+ (BATCH_SIZE, size),
+ device=device,
+ dtype=PRECISION,
+ requires_grad=False,
+ ).float()
+ pair_mask = torch.ones(
+ (BATCH_SIZE, size, size),
+ device=device,
+ dtype=PRECISION,
+ requires_grad=False,
+ ).float()
+
+ with torch.autocast("cuda", dtype=PRECISION):
+ memory_default = memory_measure(
+ lambda: fwd(
+ model,
+ s,
+ z,
+ mask,
+ pair_mask,
+ use_cuequiv_mul=False,
+ use_cuequiv_attn=False,
+ ),
+ device=device,
+ )
+ memory_attn = memory_measure(
+ lambda: fwd(
+ model,
+ s,
+ z,
+ mask,
+ pair_mask,
+ use_cuequiv_mul=False,
+ use_cuequiv_attn=True,
+ ),
+ device=device,
+ )
+ memory_mul = memory_measure(
+ lambda: fwd(
+ model,
+ s,
+ z,
+ mask,
+ pair_mask,
+ use_cuequiv_mul=True,
+ use_cuequiv_attn=False,
+ ),
+ device=device,
+ )
+ memory_flash = memory_measure(
+ lambda: fwd(
+ model,
+ s,
+ z,
+ mask,
+ pair_mask,
+ use_cuequiv_mul=True,
+ use_cuequiv_attn=True,
+ ),
+ device=device,
+ )
+ df.append(
+ {
+ "size": size,
+ "Default": memory_default - start_mem,
+ "TriAttn": memory_attn - start_mem,
+ "Trimul": memory_mul - start_mem,
+ "TriAttn+Trimul": memory_flash - start_mem,
+ }
+ )
+
+df = pd.DataFrame(df)
+print("Memory")
+print(df)
diff --git a/forks/boltz/tests/test_regression.py b/forks/boltz/tests/test_regression.py
new file mode 100644
index 00000000..5478a47f
--- /dev/null
+++ b/forks/boltz/tests/test_regression.py
@@ -0,0 +1,113 @@
+import os
+import pickle
+from dataclasses import asdict
+import pprint
+
+import torch
+import torch.nn as nn
+
+import pytest
+import unittest
+
+from lightning_fabric import seed_everything
+
+from boltz.main import MODEL_URL
+from boltz.model.model import Boltz1
+
+import test_utils
+
+tests_dir = os.path.dirname(os.path.abspath(__file__))
+test_data_dir = os.path.join(tests_dir, "data")
+
+
+@pytest.mark.regression
+class RegressionTester(unittest.TestCase):
+ @classmethod
+ def setUpClass(cls):
+ device = torch.device("cuda" if torch.cuda.is_available() else "cpu")
+ cache = os.path.expanduser("~/.boltz")
+ checkpoint_url = MODEL_URL
+ model_name = checkpoint_url.split("/")[-1]
+ checkpoint = os.path.join(cache, model_name)
+ if not os.path.exists(checkpoint):
+ test_utils.download_file(checkpoint_url, checkpoint)
+
+ regression_feats_path = os.path.join(
+ test_data_dir, "ligand_regression_feats.pkl"
+ )
+ if not os.path.exists(regression_feats_path):
+ regression_feats_url = "https://www.dropbox.com/scl/fi/1avbcvoor5jcnvpt07tp6/ligand_regression_feats.pkl?rlkey=iwtm9gpxgrbp51jbizq937pqf&st=jnbky253&dl=1"
+ test_utils.download_file(regression_feats_url, regression_feats_path)
+
+ regression_feats = torch.load(regression_feats_path, map_location=device)
+ model_module: nn.Module = Boltz1.load_from_checkpoint(
+ checkpoint, map_location=device
+ )
+ model_module.to(device)
+ model_module.eval()
+
+ coords = regression_feats["feats"]["coords"]
+ # Coords should be rank 4
+ if len(coords.shape) == 3:
+ coords = coords.unsqueeze(0)
+ regression_feats["feats"]["coords"] = coords
+ for key, val in regression_feats["feats"].items():
+ if hasattr(val, "to"):
+ regression_feats["feats"][key] = val.to(device)
+
+ cls.model_module = model_module.to(device)
+ cls.regression_feats = regression_feats
+
+ def test_input_embedder(self):
+ exp_s_inputs = self.regression_feats["s_inputs"]
+ act_s_inputs = self.model_module.input_embedder(self.regression_feats["feats"])
+
+ assert torch.allclose(exp_s_inputs, act_s_inputs, atol=1e-5)
+
+ def test_rel_pos(self):
+ exp_rel_pos_encoding = self.regression_feats["relative_position_encoding"]
+ act_rel_pos_encoding = self.model_module.rel_pos(self.regression_feats["feats"])
+
+ assert torch.allclose(exp_rel_pos_encoding, act_rel_pos_encoding, atol=1e-5)
+
+ @pytest.mark.slow
+ def test_structure_output(self):
+ exp_structure_output = self.regression_feats["structure_output"]
+ s = self.regression_feats["s"]
+ z = self.regression_feats["z"]
+ s_inputs = self.regression_feats["s_inputs"]
+ feats = self.regression_feats["feats"]
+ relative_position_encoding = self.regression_feats["relative_position_encoding"]
+ multiplicity_diffusion_train = self.regression_feats[
+ "multiplicity_diffusion_train"
+ ]
+
+ self.model_module.structure_module.coordinate_augmentation = False
+ self.model_module.structure_module.sigma_data = 0.0
+
+ seed_everything(self.regression_feats["seed"])
+ act_structure_output = self.model_module.structure_module(
+ s_trunk=s,
+ z_trunk=z,
+ s_inputs=s_inputs,
+ feats=feats,
+ relative_position_encoding=relative_position_encoding,
+ multiplicity=multiplicity_diffusion_train,
+ )
+
+ act_keys = act_structure_output.keys()
+ exp_keys = exp_structure_output.keys()
+ assert act_keys == exp_keys
+
+ # Other keys have some randomness, so we will only check the keys that
+ # we can make deterministic with sigma_data = 0.0 (above).
+ check_keys = ["noised_atom_coords", "aligned_true_atom_coords"]
+ for key in check_keys:
+ exp_val = exp_structure_output[key]
+ act_val = act_structure_output[key]
+ assert exp_val.shape == act_val.shape, f"Shape mismatch in {key}"
+ assert torch.allclose(exp_val, act_val, atol=1e-4)
+
+
+if __name__ == "__main__":
+ unittest.main()
diff --git a/forks/boltz/tests/test_utils.py b/forks/boltz/tests/test_utils.py
new file mode 100644
index 00000000..ca677b36
--- /dev/null
+++ b/forks/boltz/tests/test_utils.py
@@ -0,0 +1,22 @@
+import os
+
+import requests
+
+
+def download_file(url, filepath, verbose=True):
+ if verbose:
+ print(f"Downloading {url} to {filepath}")
+ response = requests.get(url)
+
+ target_dir = os.path.dirname(filepath)
+ if target_dir and not os.path.exists(target_dir):
+ os.makedirs(target_dir)
+
+ # Check if the request was successful
+ if response.status_code == 200:
+ with open(filepath, "wb") as file:
+ file.write(response.content)
+ else:
+ print(f"Failed to download file. Status code: {response.status_code}")
+
+ return filepath
diff --git a/notebooks/astex_diverse_inference_results_plotting.ipynb b/notebooks/astex_diverse_inference_results_plotting.ipynb
index 97e8e601..4e296a83 100644
--- a/notebooks/astex_diverse_inference_results_plotting.ipynb
+++ b/notebooks/astex_diverse_inference_results_plotting.ipynb
@@ -68,6 +68,8 @@
" \"rfaa\",\n",
" \"chai-lab_ss\",\n",
" \"chai-lab\",\n",
+ " \"boltz_ss\",\n",
+ " \"boltz\",\n",
" \"alphafold3_ss\",\n",
" \"alphafold3\",\n",
"]\n",
@@ -82,6 +84,7 @@
"globals()[\"neuralplexer_output_dir\"] = os.path.join(\"..\", \"forks\", \"NeuralPLexer\", \"inference\")\n",
"globals()[\"rfaa_output_dir\"] = os.path.join(\"..\", \"forks\", \"RoseTTAFold-All-Atom\", \"inference\")\n",
"globals()[\"chai-lab_output_dir\"] = os.path.join(\"..\", \"forks\", \"chai-lab\", \"inference\")\n",
+ "globals()[\"boltz_output_dir\"] = os.path.join(\"..\", \"forks\", \"boltz\", \"inference\")\n",
"globals()[\"alphafold3_output_dir\"] = os.path.join(\"..\", \"forks\", \"alphafold3\", \"inference\")\n",
"for repeat_index in range(1, max_num_repeats_per_method + 1):\n",
" # PLIF metrics\n",
@@ -179,6 +182,30 @@
" \"bust_results.csv\",\n",
" )\n",
"\n",
+ " # Boltz (Single-Seq) results\n",
+ " globals()[f\"boltz_ss_astex_bust_results_csv_filepath_{repeat_index}\"] = os.path.join(\n",
+ " globals()[\"boltz_output_dir\"],\n",
+ " f\"boltz_ss_astex_diverse_outputs_{repeat_index}\",\n",
+ " \"bust_results.csv\",\n",
+ " )\n",
+ " globals()[f\"boltz_ss_astex_relaxed_bust_results_csv_filepath_{repeat_index}\"] = os.path.join(\n",
+ " globals()[\"boltz_output_dir\"],\n",
+ " f\"boltz_ss_astex_diverse_outputs_{repeat_index}_relaxed\",\n",
+ " \"bust_results.csv\",\n",
+ " )\n",
+ "\n",
+ " # Boltz results\n",
+ " globals()[f\"boltz_astex_bust_results_csv_filepath_{repeat_index}\"] = os.path.join(\n",
+ " globals()[\"boltz_output_dir\"],\n",
+ " f\"boltz_astex_diverse_outputs_{repeat_index}\",\n",
+ " \"bust_results.csv\",\n",
+ " )\n",
+ " globals()[f\"boltz_astex_relaxed_bust_results_csv_filepath_{repeat_index}\"] = os.path.join(\n",
+ " globals()[\"boltz_output_dir\"],\n",
+ " f\"boltz_astex_diverse_outputs_{repeat_index}_relaxed\",\n",
+ " \"bust_results.csv\",\n",
+ " )\n",
+ "\n",
" # AlphaFold 3 (Single-Seq) results\n",
" globals()[f\"alphafold3_ss_astex_bust_results_csv_filepath_{repeat_index}\"] = os.path.join(\n",
" globals()[\"alphafold3_output_dir\"],\n",
@@ -214,6 +241,8 @@
" \"rfaa\": \"RFAA\",\n",
" \"chai-lab_ss\": \"Chai-1-Single-Seq\",\n",
" \"chai-lab\": \"Chai-1\",\n",
+ " \"boltz_ss\": \"Boltz-1-Single-Seq\",\n",
+ " \"boltz\": \"Boltz-1\",\n",
" \"alphafold3_ss\": \"AF3-Single-Seq\",\n",
" \"alphafold3\": \"AF3\",\n",
"}\n",
@@ -226,6 +255,8 @@
" \"rfaa\": \"DL-based blind\",\n",
" \"chai-lab_ss\": \"DL-based blind\",\n",
" \"chai-lab\": \"DL-based blind\",\n",
+ " \"boltz_ss\": \"DL-based blind\",\n",
+ " \"boltz\": \"DL-based blind\",\n",
" \"alphafold3_ss\": \"DL-based blind\",\n",
" \"alphafold3\": \"DL-based blind\",\n",
"}"
@@ -505,7 +536,7 @@
"colors = [\"#AB8042\", \"#FB8072\", \"#BEBADA\", \"#FCCDE5\"]\n",
"\n",
"bar_width = 0.5\n",
- "r1 = [item - 0.5 for item in range(2, 20, 2)]\n",
+ "r1 = [item - 0.5 for item in range(2, 24, 2)]\n",
"r2 = [x + bar_width for x in r1]\n",
"r3 = [x + bar_width for x in r2]\n",
"\n",
@@ -883,7 +914,7 @@
"\n",
"# add labels, titles, ticks, etc.\n",
"axis.set_ylabel(\"Percentage of predictions\")\n",
- "axis.set_xlim(1, 19 + 0.1)\n",
+ "axis.set_xlim(1, 23 + 0.1)\n",
"axis.set_ylim(0, 150)\n",
"\n",
"assert all(\n",
@@ -1018,7 +1049,7 @@
"axis.grid(axis=\"y\", color=\"#EAEFF8\")\n",
"axis.set_axisbelow(True)\n",
"\n",
- "axis.set_xticks([2, 2 + 1e-3, 4, 6, 8, 10, 11, 12, 14, 16, 18])\n",
+ "axis.set_xticks([2, 2 + 1e-3, 4, 6, 8, 10, 12, 13, 14, 16, 18, 20, 22])\n",
"axis.set_xticks([1 + 0.1], minor=True)\n",
"axis.set_xticklabels(\n",
" [\n",
@@ -1028,9 +1059,11 @@
" \"DynamicBind\",\n",
" \"NeuralPLexer\",\n",
" \"RFAA\",\n",
- " \"DL-based blind\",\n",
" \"Chai-1-Single-Seq\",\n",
+ " \"DL-based blind\",\n",
" \"Chai-1\",\n",
+ " \"Boltz-1-Single-Seq\",\n",
+ " \"Boltz-1\",\n",
" \"AF3-Single-Seq\",\n",
" \"AF3\",\n",
" ]\n",
@@ -1044,7 +1077,7 @@
"axis.tick_params(axis=\"y\", which=\"major\", left=\"off\", right=\"on\", color=\"#EAEFF8\")\n",
"\n",
"# vertical alignment of xtick labels\n",
- "vert_alignments = [0.0, -0.1, 0.0, 0.0, 0.0, 0.0, -0.1, 0.0, 0.0, 0.0, 0.0]\n",
+ "vert_alignments = [0.0, -0.1, 0.0, 0.0, 0.0, 0.0, 0.0, -0.1, 0.0, 0.0, 0.0, 0.0, 0.0]\n",
"for tick, y in zip(axis.get_xticklabels(), vert_alignments):\n",
" tick.set_y(y)\n",
"\n",
diff --git a/notebooks/astex_diverse_method_interaction_analysis.png b/notebooks/astex_diverse_method_interaction_analysis.png
new file mode 100644
index 00000000..56b4fdb1
Binary files /dev/null and b/notebooks/astex_diverse_method_interaction_analysis.png differ
diff --git a/notebooks/astex_diverse_plif_emd_values.png b/notebooks/astex_diverse_plif_emd_values.png
new file mode 100644
index 00000000..e85f8125
Binary files /dev/null and b/notebooks/astex_diverse_plif_emd_values.png differ
diff --git a/notebooks/astex_diverse_plif_metrics.csv b/notebooks/astex_diverse_plif_metrics.csv
new file mode 100644
index 00000000..6a2fef35
--- /dev/null
+++ b/notebooks/astex_diverse_plif_metrics.csv
@@ -0,0 +1,936 @@
+,Category,Target,EMD,WM,Method_Histogram,Reference_Histogram
+0,P2Rank-Vina,2BM2_PM2,0.22727272727272724,0.9090909090909091,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1,P2Rank-Vina,1XOQ_ROF,,0.0,,
+2,P2Rank-Vina,1M2Z_DEX,,0.0,,
+3,P2Rank-Vina,1P62_GEO,0.5333333333333332,0.7866666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+4,P2Rank-Vina,1KE5_LS1,0.7647058823529411,0.6941176470588235,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+5,P2Rank-Vina,1TT1_KAI,0.375,0.85,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+6,P2Rank-Vina,1VCJ_IBA,0.875,0.65,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+7,P2Rank-Vina,1HWI_115,0.52,0.792,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+8,P2Rank-Vina,1UML_FR4,0.21052631578947362,0.9157894736842106,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+9,P2Rank-Vina,1JLA_TNK,0.26086956521739124,0.8956521739130435,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+10,P2Rank-Vina,1N46_PFA,0.6785714285714286,0.7285714285714285,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+11,P2Rank-Vina,1LRH_NLA,,0.0,,
+12,P2Rank-Vina,1KZK_JE2,,0.0,,
+13,P2Rank-Vina,1N2J_PAF,,0.0,,
+14,P2Rank-Vina,1MEH_MOA,0.6666666666666667,0.7333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 7, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+15,P2Rank-Vina,2BSM_BSM,0.3181818181818181,0.8727272727272728,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+16,P2Rank-Vina,1V48_HA1,0.5714285714285714,0.7714285714285715,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+17,P2Rank-Vina,1L7F_BCZ,,0.0,,
+18,P2Rank-Vina,1JD0_AZM,0.10526315789473684,0.9578947368421052,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+19,P2Rank-Vina,1S19_MC9,0.17391304347826075,0.9304347826086957,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+20,P2Rank-Vina,1LPZ_CMB,0.2,0.92,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+21,P2Rank-Vina,1X8X_TYR,0.5000000000000001,0.7999999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+22,P2Rank-Vina,1T46_STI,0.5714285714285713,0.7714285714285715,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+23,P2Rank-Vina,1IG3_VIB,0.375,0.85,"{'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+24,P2Rank-Vina,1SQ5_PAU,0.16666666666666669,0.9333333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+25,P2Rank-Vina,1Q4G_BFL,,0.0,,
+26,P2Rank-Vina,1OYT_FSN,,0.0,,
+27,P2Rank-Vina,1UNL_RRC,0.380952380952381,0.8476190476190476,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+28,P2Rank-Vina,1U1C_BAU,0.44444444444444436,0.8222222222222222,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+29,P2Rank-Vina,1K3U_IAD,,0.0,,
+30,P2Rank-Vina,1G9V_RQ3,,0.0,,
+31,P2Rank-Vina,1YV3_BIT,,0.0,,
+32,P2Rank-Vina,1IA1_TQ3,,0.0,,
+33,P2Rank-Vina,1Q1G_MTI,,0.0,,
+34,P2Rank-Vina,1R1H_BIR,0.523809523809524,0.7904761904761904,"{'UNL:ASN:Hydrophobic': 3, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+35,P2Rank-Vina,1YVF_PH7,,0.0,,
+36,P2Rank-Vina,1YQY_915,0.23076923076923078,0.9076923076923077,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+37,P2Rank-Vina,1HWW_SWA,0.26315789473684215,0.8947368421052632,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+38,P2Rank-Vina,1T40_ID5,,0.0,,
+39,P2Rank-Vina,1GKC_NFH,,0.0,,
+40,P2Rank-Vina,1N1M_A3M,,0.0,,
+41,P2Rank-Vina,1Z95_198,0.2631578947368421,0.8947368421052632,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 5, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+42,P2Rank-Vina,1HP0_AD3,0.5384615384615385,0.7846153846153846,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+43,P2Rank-Vina,1OF1_SCT,0.380952380952381,0.8476190476190476,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+44,P2Rank-Vina,1SJ0_E4D,0.2962962962962962,0.8814814814814815,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 5, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+45,P2Rank-Vina,1U4D_DBQ,0.30769230769230765,0.8769230769230769,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+46,P2Rank-Vina,1Q41_IXM,0.1578947368421052,0.9368421052631579,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+47,P2Rank-Vina,1OWE_675,0.3571428571428572,0.8571428571428571,"{'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+48,P2Rank-Vina,1OQ5_CEL,0.29999999999999993,0.88,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+49,P2Rank-Vina,1SG0_STL,,0.0,,
+50,P2Rank-Vina,2BR1_PFP,0.1764705882352941,0.9294117647058824,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+51,P2Rank-Vina,1UOU_CMU,0.4444444444444444,0.8222222222222222,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+52,P2Rank-Vina,1TZ8_DES,,0.0,,
+53,P2Rank-Vina,1R9O_FLP,,0.0,,
+54,P2Rank-Vina,1P2Y_NCT,,0.0,,
+55,P2Rank-Vina,1V0P_PVB,0.21052631578947367,0.9157894736842105,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+56,P2Rank-Vina,1XOZ_CIA,0.3999999999999999,0.8400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+57,P2Rank-Vina,1R55_097,,0.0,,
+58,P2Rank-Vina,1YWR_LI9,0.42857142857142866,0.8285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+59,P2Rank-Vina,1HQ2_PH2,,0.0,,
+60,P2Rank-Vina,1MZC_BNE,,0.0,,
+61,P2Rank-Vina,1V4S_MRK,,0.0,,
+62,P2Rank-Vina,1NAV_IH5,0.0625,0.975,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+63,P2Rank-Vina,1JJE_BYS,,0.0,,
+64,P2Rank-Vina,1GM8_SOX,0.1875,0.925,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2}"
+65,P2Rank-Vina,1J3J_CP6,,0.0,,
+66,P2Rank-Vina,1T9B_1CS,,0.0,,
+67,P2Rank-Vina,1PMN_984,,0.0,,
+68,P2Rank-Vina,1N2V_BDI,0.125,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+69,P2Rank-Vina,1GPK_HUP,0.5,0.8,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+70,P2Rank-Vina,1W1P_GIO,,0.0,,
+71,P2Rank-Vina,1OF6_DTY,,0.0,,
+72,P2Rank-Vina,1S3V_TQD,0.33333333333333337,0.8666666666666667,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+73,P2Rank-Vina,1Y6B_AAX,0.5294117647058822,0.7882352941176471,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+74,P2Rank-Vina,1L2S_STC,0.375,0.85,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+75,P2Rank-Vina,1W2G_THM,0.5,0.8,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+76,P2Rank-Vina,1TOW_CRZ,0.16666666666666669,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+77,P2Rank-Vina,1XM6_5RM,0.2222222222222223,0.9111111111111111,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+78,P2Rank-Vina,1YGC_905,0.42105263157894746,0.831578947368421,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+79,P2Rank-Vina,1R58_AO5,0.09090909090909088,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+80,P2Rank-Vina,1HNN_SKF,0.1875,0.925,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+81,P2Rank-Vina,1HVY_D16,0.2962962962962963,0.8814814814814815,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:UMP:Hydrophobic': 1, 'UNL:UMP:VdWContact': 1}"
+82,P2Rank-Vina,1OPK_P16,0.65,0.74,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+83,P2Rank-Vina,1MMV_3AR,,0.0,,
+84,P2Rank-Vina,1SQN_NDR,0.1875,0.925,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+85,DiffDock-L,2BM2_PM2,0.29411764705882354,0.8823529411764706,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+86,DiffDock-L,1XOQ_ROF,0.35294117647058826,0.8588235294117648,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+87,DiffDock-L,1M2Z_DEX,0.26086956521739135,0.8956521739130434,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+88,DiffDock-L,1P62_GEO,0.35294117647058826,0.8588235294117648,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+89,DiffDock-L,1KE5_LS1,0.09999999999999999,0.96,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+90,DiffDock-L,1TT1_KAI,0.6666666666666666,0.7333333333333334,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+91,DiffDock-L,1VCJ_IBA,0.23529411764705885,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+92,DiffDock-L,1HWI_115,0.08333333333333337,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+93,DiffDock-L,1UML_FR4,0.6315789473684211,0.7473684210526316,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 4, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+94,DiffDock-L,1JLA_TNK,0.368421052631579,0.8526315789473684,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+95,DiffDock-L,1N46_PFA,0.09523809523809518,0.9619047619047619,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+96,DiffDock-L,1LRH_NLA,0.06666666666666667,0.9733333333333334,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+97,DiffDock-L,1KZK_JE2,0.8,0.6799999999999999,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+98,DiffDock-L,1N2J_PAF,0.22222222222222227,0.9111111111111111,"{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+99,DiffDock-L,1MEH_MOA,0.4210526315789474,0.831578947368421,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+100,DiffDock-L,2BSM_BSM,0.04999999999999999,0.98,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+101,DiffDock-L,1V48_HA1,0.14999999999999997,0.9400000000000001,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+102,DiffDock-L,1L7F_BCZ,0.3125,0.875,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 6, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+103,DiffDock-L,1JD0_AZM,0.1,0.96,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+104,DiffDock-L,1S19_MC9,0.0869565217391304,0.9652173913043478,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+105,DiffDock-L,1LPZ_CMB,0.052631578947368474,0.9789473684210526,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+106,DiffDock-L,1X8X_TYR,0.3333333333333333,0.8666666666666667,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+107,DiffDock-L,1T46_STI,0.2692307692307692,0.8923076923076924,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+108,DiffDock-L,1IG3_VIB,0.3157894736842106,0.8736842105263157,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+109,DiffDock-L,1SQ5_PAU,0.2666666666666666,0.8933333333333333,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+110,DiffDock-L,1Q4G_BFL,,0.0,,
+111,DiffDock-L,1OYT_FSN,0.17647058823529413,0.9294117647058824,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+112,DiffDock-L,1UNL_RRC,0.10526315789473684,0.9578947368421052,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+113,DiffDock-L,1U1C_BAU,0.23529411764705882,0.9058823529411765,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+114,DiffDock-L,1K3U_IAD,0.6818181818181818,0.7272727272727273,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+115,DiffDock-L,1G9V_RQ3,,0.0,,
+116,DiffDock-L,1YV3_BIT,,0.0,,
+117,DiffDock-L,1IA1_TQ3,0.47058823529411775,0.8117647058823529,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+118,DiffDock-L,1Q1G_MTI,0.0869565217391304,0.9652173913043478,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+119,DiffDock-L,1R1H_BIR,0.42105263157894746,0.831578947368421,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+120,DiffDock-L,1YVF_PH7,0.04166666666666663,0.9833333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+121,DiffDock-L,1YQY_915,0.23809523809523808,0.9047619047619048,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+122,DiffDock-L,1HWW_SWA,0.07692307692307698,0.9692307692307692,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+123,DiffDock-L,1T40_ID5,0.7894736842105263,0.6842105263157895,"{'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+124,DiffDock-L,1GKC_NFH,,0.0,,
+125,DiffDock-L,1N1M_A3M,0.2,0.92,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2}"
+126,DiffDock-L,1Z95_198,0.1875,0.925,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+127,DiffDock-L,1HP0_AD3,0.1818181818181818,0.9272727272727272,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+128,DiffDock-L,1OF1_SCT,0.052631578947368474,0.9789473684210526,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+129,DiffDock-L,1SJ0_E4D,0.24000000000000005,0.904,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+130,DiffDock-L,1U4D_DBQ,0.1538461538461539,0.9384615384615385,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+131,DiffDock-L,1Q41_IXM,0.1111111111111111,0.9555555555555556,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+132,DiffDock-L,1OWE_675,0.24999999999999992,0.9,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+133,DiffDock-L,1OQ5_CEL,0.22222222222222215,0.9111111111111111,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+134,DiffDock-L,1SG0_STL,0.388888888888889,0.8444444444444443,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+135,DiffDock-L,2BR1_PFP,0.4615384615384615,0.8153846153846154,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+136,DiffDock-L,1UOU_CMU,0.4000000000000001,0.84,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+137,DiffDock-L,1TZ8_DES,0.45454545454545453,0.8181818181818181,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}"
+138,DiffDock-L,1R9O_FLP,,0.0,,
+139,DiffDock-L,1P2Y_NCT,,0.0,,
+140,DiffDock-L,1V0P_PVB,0.4444444444444444,0.8222222222222222,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+141,DiffDock-L,1XOZ_CIA,0.125,0.95,"{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+142,DiffDock-L,1R55_097,0.19999999999999998,0.92,"{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+143,DiffDock-L,1YWR_LI9,0.3000000000000001,0.88,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+144,DiffDock-L,1HQ2_PH2,0.11764705882352942,0.9529411764705882,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+145,DiffDock-L,1MZC_BNE,0.15384615384615385,0.9384615384615385,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+146,DiffDock-L,1V4S_MRK,0.22222222222222227,0.9111111111111111,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+147,DiffDock-L,1NAV_IH5,0.0625,0.975,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+148,DiffDock-L,1JJE_BYS,0.4210526315789474,0.831578947368421,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+149,DiffDock-L,1GM8_SOX,0.14285714285714282,0.9428571428571428,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2}"
+150,DiffDock-L,1J3J_CP6,0.29411764705882354,0.8823529411764706,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+151,DiffDock-L,1T9B_1CS,,0.0,,
+152,DiffDock-L,1PMN_984,,0.0,,
+153,DiffDock-L,1N2V_BDI,0.08333333333333326,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+154,DiffDock-L,1GPK_HUP,0.29999999999999993,0.88,"{'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+155,DiffDock-L,1W1P_GIO,0.16666666666666657,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+156,DiffDock-L,1OF6_DTY,,0.0,,
+157,DiffDock-L,1S3V_TQD,0.3571428571428572,0.8571428571428571,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+158,DiffDock-L,1Y6B_AAX,0.3529411764705882,0.8588235294117648,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+159,DiffDock-L,1L2S_STC,0.13333333333333336,0.9466666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+160,DiffDock-L,1W2G_THM,0.2857142857142857,0.8857142857142857,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+161,DiffDock-L,1TOW_CRZ,0.23529411764705885,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+162,DiffDock-L,1XM6_5RM,0.2666666666666667,0.8933333333333333,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+163,DiffDock-L,1YGC_905,0.17647058823529416,0.9294117647058824,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+164,DiffDock-L,1R58_AO5,0.05882352941176472,0.9764705882352941,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+165,DiffDock-L,1HNN_SKF,0.19999999999999996,0.92,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+166,DiffDock-L,1HVY_D16,0.5499999999999999,0.78,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:UMP:Hydrophobic': 1, 'UNL:UMP:VdWContact': 1}"
+167,DiffDock-L,1OPK_P16,0.19047619047619047,0.9238095238095239,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+168,DiffDock-L,1MMV_3AR,,0.0,,
+169,DiffDock-L,1SQN_NDR,0.25,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+170,DynamicBind,2BM2_PM2,,0.0,,
+171,DynamicBind,1XOQ_ROF,,0.0,,
+172,DynamicBind,1M2Z_DEX,0.2083333333333334,0.9166666666666666,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+173,DynamicBind,1P62_GEO,0.06666666666666665,0.9733333333333334,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+174,DynamicBind,1KE5_LS1,0.26315789473684204,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+175,DynamicBind,1TT1_KAI,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+176,DynamicBind,1VCJ_IBA,,0.0,,
+177,DynamicBind,1HWI_115,0.25925925925925924,0.8962962962962963,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+178,DynamicBind,1UML_FR4,0.33333333333333337,0.8666666666666667,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+179,DynamicBind,1JLA_TNK,0.05555555555555558,0.9777777777777777,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+180,DynamicBind,1N46_PFA,0.26086956521739135,0.8956521739130434,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+181,DynamicBind,1LRH_NLA,,0.0,,
+182,DynamicBind,1KZK_JE2,,0.0,,
+183,DynamicBind,1N2J_PAF,,0.0,,
+184,DynamicBind,1MEH_MOA,0.14285714285714288,0.9428571428571428,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+185,DynamicBind,2BSM_BSM,0.047619047619047616,0.9809523809523809,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+186,DynamicBind,1V48_HA1,0.1428571428571428,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+187,DynamicBind,1L7F_BCZ,0.4444444444444445,0.8222222222222222,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 6, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+188,DynamicBind,1JD0_AZM,0.29999999999999993,0.88,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+189,DynamicBind,1S19_MC9,,0.0,,
+190,DynamicBind,1LPZ_CMB,0.10526315789473684,0.9578947368421052,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+191,DynamicBind,1X8X_TYR,,0.0,,
+192,DynamicBind,1T46_STI,0.3214285714285714,0.8714285714285714,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+193,DynamicBind,1IG3_VIB,0.2,0.92,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+194,DynamicBind,1SQ5_PAU,,0.0,,
+195,DynamicBind,1Q4G_BFL,,0.0,,
+196,DynamicBind,1OYT_FSN,0.11764705882352942,0.9529411764705882,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+197,DynamicBind,1UNL_RRC,,0.0,,
+198,DynamicBind,1U1C_BAU,,0.0,,
+199,DynamicBind,1K3U_IAD,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+200,DynamicBind,1G9V_RQ3,0.5,0.8,"{'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+201,DynamicBind,1YV3_BIT,,0.0,,
+202,DynamicBind,1IA1_TQ3,0.4285714285714286,0.8285714285714285,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+203,DynamicBind,1Q1G_MTI,0.13636363636363638,0.9454545454545454,"{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+204,DynamicBind,1R1H_BIR,0.35000000000000003,0.86,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+205,DynamicBind,1YVF_PH7,,0.0,,
+206,DynamicBind,1YQY_915,,0.0,,
+207,DynamicBind,1HWW_SWA,0.14285714285714282,0.9428571428571428,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+208,DynamicBind,1T40_ID5,0.3999999999999999,0.8400000000000001,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+209,DynamicBind,1GKC_NFH,0.29166666666666674,0.8833333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+210,DynamicBind,1N1M_A3M,,0.0,,
+211,DynamicBind,1Z95_198,,0.0,,
+212,DynamicBind,1HP0_AD3,0.21428571428571433,0.9142857142857143,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+213,DynamicBind,1OF1_SCT,0.22222222222222227,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+214,DynamicBind,1SJ0_E4D,,0.0,,
+215,DynamicBind,1U4D_DBQ,0.39999999999999997,0.8400000000000001,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+216,DynamicBind,1Q41_IXM,0.11111111111111102,0.9555555555555556,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+217,DynamicBind,1OWE_675,0.0,1.0,"{'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+218,DynamicBind,1OQ5_CEL,0.28571428571428564,0.8857142857142858,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+219,DynamicBind,1SG0_STL,,0.0,,
+220,DynamicBind,2BR1_PFP,,0.0,,
+221,DynamicBind,1UOU_CMU,0.5714285714285714,0.7714285714285715,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+222,DynamicBind,1TZ8_DES,,0.0,,
+223,DynamicBind,1R9O_FLP,,0.0,,
+224,DynamicBind,1P2Y_NCT,,0.0,,
+225,DynamicBind,1V0P_PVB,,0.0,,
+226,DynamicBind,1XOZ_CIA,,0.0,,
+227,DynamicBind,1R55_097,0.4375,0.825,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 4, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+228,DynamicBind,1YWR_LI9,,0.0,,
+229,DynamicBind,1HQ2_PH2,0.2222222222222222,0.9111111111111111,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+230,DynamicBind,1MZC_BNE,0.7142857142857143,0.7142857142857143,"{'UNL:ALA:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 5, 'UNL:TYR:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+231,DynamicBind,1V4S_MRK,,0.0,,
+232,DynamicBind,1NAV_IH5,0.0625,0.975,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+233,DynamicBind,1JJE_BYS,0.13636363636363635,0.9454545454545454,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+234,DynamicBind,1GM8_SOX,0.31578947368421056,0.8736842105263158,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2}"
+235,DynamicBind,1J3J_CP6,,0.0,,
+236,DynamicBind,1T9B_1CS,,0.0,,
+237,DynamicBind,1PMN_984,0.411764705882353,0.8352941176470587,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+238,DynamicBind,1N2V_BDI,0.23076923076923078,0.9076923076923077,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+239,DynamicBind,1GPK_HUP,0.19999999999999996,0.92,"{'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+240,DynamicBind,1W1P_GIO,,0.0,,
+241,DynamicBind,1OF6_DTY,,0.0,,
+242,DynamicBind,1S3V_TQD,,0.0,,
+243,DynamicBind,1Y6B_AAX,0.2500000000000001,0.8999999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+244,DynamicBind,1L2S_STC,0.1875,0.925,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+245,DynamicBind,1W2G_THM,,0.0,,
+246,DynamicBind,1TOW_CRZ,0.11764705882352941,0.9529411764705882,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+247,DynamicBind,1XM6_5RM,,0.0,,
+248,DynamicBind,1YGC_905,0.15789473684210525,0.9368421052631579,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+249,DynamicBind,1R58_AO5,,0.0,,
+250,DynamicBind,1HNN_SKF,,0.0,,
+251,DynamicBind,1HVY_D16,0.7142857142857142,0.7142857142857143,"{'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:UMP:Hydrophobic': 1, 'UNL:UMP:VdWContact': 1}"
+252,DynamicBind,1OPK_P16,,0.0,,
+253,DynamicBind,1MMV_3AR,0.4642857142857143,0.8142857142857143,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+254,DynamicBind,1SQN_NDR,0.17647058823529413,0.9294117647058824,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+255,NeuralPLexer,2BM2_PM2,0.6875,0.725,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+256,NeuralPLexer,1XOQ_ROF,0.35714285714285704,0.8571428571428572,"{'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+257,NeuralPLexer,1M2Z_DEX,0.5652173913043478,0.7739130434782608,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+258,NeuralPLexer,1P62_GEO,0.3333333333333333,0.8666666666666667,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+259,NeuralPLexer,1KE5_LS1,0.36842105263157887,0.8526315789473684,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+260,NeuralPLexer,1TT1_KAI,0.4210526315789474,0.831578947368421,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+261,NeuralPLexer,1VCJ_IBA,0.2777777777777777,0.888888888888889,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+262,NeuralPLexer,1HWI_115,0.4074074074074074,0.837037037037037,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+263,NeuralPLexer,1UML_FR4,0.26666666666666666,0.8933333333333333,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+264,NeuralPLexer,1JLA_TNK,0.2500000000000001,0.8999999999999999,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+265,NeuralPLexer,1N46_PFA,0.4782608695652174,0.808695652173913,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+266,NeuralPLexer,1LRH_NLA,0.33333333333333337,0.8666666666666667,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+267,NeuralPLexer,1KZK_JE2,0.7857142857142857,0.6857142857142857,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+268,NeuralPLexer,1N2J_PAF,0.5000000000000001,0.7999999999999999,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+269,NeuralPLexer,1MEH_MOA,0.4210526315789474,0.831578947368421,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+270,NeuralPLexer,2BSM_BSM,0.08695652173913046,0.9652173913043478,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+271,NeuralPLexer,1V48_HA1,0.09090909090909097,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+272,NeuralPLexer,1L7F_BCZ,0.44444444444444436,0.8222222222222222,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+273,NeuralPLexer,1JD0_AZM,0.4545454545454545,0.8181818181818182,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+274,NeuralPLexer,1S19_MC9,0.26086956521739113,0.8956521739130435,"{'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+275,NeuralPLexer,1LPZ_CMB,0.35,0.86,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+276,NeuralPLexer,1X8X_TYR,0.49999999999999994,0.8,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+277,NeuralPLexer,1T46_STI,0.2962962962962963,0.8814814814814815,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+278,NeuralPLexer,1IG3_VIB,0.2857142857142858,0.8857142857142857,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+279,NeuralPLexer,1SQ5_PAU,0.10000000000000003,0.96,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+280,NeuralPLexer,1Q4G_BFL,0.11764705882352944,0.9529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+281,NeuralPLexer,1OYT_FSN,0.23529411764705885,0.9058823529411765,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+282,NeuralPLexer,1UNL_RRC,0.5909090909090909,0.7636363636363637,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+283,NeuralPLexer,1U1C_BAU,0.3333333333333333,0.8666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+284,NeuralPLexer,1K3U_IAD,0.4193548387096773,0.832258064516129,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+285,NeuralPLexer,1G9V_RQ3,0.25000000000000006,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+286,NeuralPLexer,1YV3_BIT,0.6086956521739131,0.7565217391304347,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+287,NeuralPLexer,1IA1_TQ3,0.38461538461538464,0.8461538461538461,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+288,NeuralPLexer,1Q1G_MTI,0.3333333333333333,0.8666666666666667,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+289,NeuralPLexer,1R1H_BIR,0.45000000000000007,0.82,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+290,NeuralPLexer,1YVF_PH7,0.30434782608695643,0.8782608695652174,"{'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+291,NeuralPLexer,1YQY_915,0.09090909090909088,0.9636363636363636,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+292,NeuralPLexer,1HWW_SWA,0.1538461538461538,0.9384615384615385,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 4, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+293,NeuralPLexer,1T40_ID5,0.4,0.84,"{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+294,NeuralPLexer,1GKC_NFH,0.31818181818181823,0.8727272727272727,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+295,NeuralPLexer,1N1M_A3M,0.3125,0.875,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2}"
+296,NeuralPLexer,1Z95_198,0.7333333333333334,0.7066666666666667,"{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+297,NeuralPLexer,1HP0_AD3,0.07142857142857142,0.9714285714285714,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+298,NeuralPLexer,1OF1_SCT,0.368421052631579,0.8526315789473684,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+299,NeuralPLexer,1SJ0_E4D,0.11538461538461542,0.9538461538461538,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+300,NeuralPLexer,1U4D_DBQ,0.6000000000000001,0.76,"{'UNL:ALA:Hydrophobic': 3, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBDonor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+301,NeuralPLexer,1Q41_IXM,0.21052631578947373,0.9157894736842105,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+302,NeuralPLexer,1OWE_675,0.25,0.9,"{'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+303,NeuralPLexer,1OQ5_CEL,0.21052631578947373,0.9157894736842105,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+304,NeuralPLexer,1SG0_STL,0.6666666666666667,0.7333333333333333,"{'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+305,NeuralPLexer,2BR1_PFP,0.4375,0.825,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+306,NeuralPLexer,1UOU_CMU,0.5625,0.775,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+307,NeuralPLexer,1TZ8_DES,1.3333333333333333,0.4666666666666667,"{'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 5}","{'UNL:ALA:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}"
+308,NeuralPLexer,1R9O_FLP,0.2631578947368422,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+309,NeuralPLexer,1P2Y_NCT,0.08333333333333326,0.9666666666666667,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+310,NeuralPLexer,1V0P_PVB,0.16666666666666674,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+311,NeuralPLexer,1XOZ_CIA,0.11764705882352933,0.9529411764705883,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+312,NeuralPLexer,1R55_097,0.4375,0.825,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+313,NeuralPLexer,1YWR_LI9,0.55,0.78,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+314,NeuralPLexer,1HQ2_PH2,0.23529411764705882,0.9058823529411765,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+315,NeuralPLexer,1MZC_BNE,0.2857142857142856,0.8857142857142858,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+316,NeuralPLexer,1V4S_MRK,0.13043478260869573,0.9478260869565217,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+317,NeuralPLexer,1NAV_IH5,0.25,0.9,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+318,NeuralPLexer,1JJE_BYS,0.7058823529411765,0.7176470588235294,"{'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+319,NeuralPLexer,1GM8_SOX,0.27777777777777785,0.8888888888888888,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2}"
+320,NeuralPLexer,1J3J_CP6,0.2941176470588236,0.8823529411764706,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+321,NeuralPLexer,1T9B_1CS,0.4375,0.825,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+322,NeuralPLexer,1PMN_984,0.33333333333333326,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+323,NeuralPLexer,1N2V_BDI,0.07692307692307687,0.9692307692307692,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+324,NeuralPLexer,1GPK_HUP,0.5555555555555556,0.7777777777777778,"{'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+325,NeuralPLexer,1W1P_GIO,0.8333333333333333,0.6666666666666667,"{'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+326,NeuralPLexer,1OF6_DTY,,0.0,,
+327,NeuralPLexer,1S3V_TQD,0.1333333333333333,0.9466666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+328,NeuralPLexer,1Y6B_AAX,0.09090909090909088,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+329,NeuralPLexer,1L2S_STC,0.33333333333333326,0.8666666666666667,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+330,NeuralPLexer,1W2G_THM,0.26666666666666666,0.8933333333333333,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+331,NeuralPLexer,1TOW_CRZ,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+332,NeuralPLexer,1XM6_5RM,0.5625,0.775,"{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+333,NeuralPLexer,1YGC_905,0.16666666666666669,0.9333333333333333,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 4, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+334,NeuralPLexer,1R58_AO5,0.2857142857142857,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+335,NeuralPLexer,1HNN_SKF,0.23529411764705885,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+336,NeuralPLexer,1HVY_D16,0.17391304347826084,0.9304347826086956,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:UMP:Hydrophobic': 1, 'UNL:UMP:VdWContact': 1}"
+337,NeuralPLexer,1OPK_P16,0.1904761904761904,0.9238095238095239,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+338,NeuralPLexer,1MMV_3AR,0.5,0.8,"{'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+339,NeuralPLexer,1SQN_NDR,0.1875,0.925,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+340,RFAA,2BM2_PM2,,0.0,,
+341,RFAA,1XOQ_ROF,,0.0,,
+342,RFAA,1M2Z_DEX,,0.0,,
+343,RFAA,1P62_GEO,0.05882352941176472,0.9764705882352941,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+344,RFAA,1KE5_LS1,0.7058823529411764,0.7176470588235294,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+345,RFAA,1TT1_KAI,0.19230769230769235,0.923076923076923,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+346,RFAA,1VCJ_IBA,0.7777777777777778,0.6888888888888889,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+347,RFAA,1HWI_115,,0.0,,
+348,RFAA,1UML_FR4,0.10526315789473678,0.9578947368421052,"{'UNL:ASP:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+349,RFAA,1JLA_TNK,,0.0,,
+350,RFAA,1N46_PFA,0.5833333333333331,0.7666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+351,RFAA,1LRH_NLA,,0.0,,
+352,RFAA,1KZK_JE2,0.6875,0.725,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 5, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PRO:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+353,RFAA,1N2J_PAF,,0.0,,
+354,RFAA,1MEH_MOA,0.25,0.9,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+355,RFAA,2BSM_BSM,0.26086956521739135,0.8956521739130434,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+356,RFAA,1V48_HA1,0.44999999999999996,0.8200000000000001,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+357,RFAA,1L7F_BCZ,0.36842105263157887,0.8526315789473684,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+358,RFAA,1JD0_AZM,,0.0,,
+359,RFAA,1S19_MC9,0.6086956521739131,0.7565217391304347,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+360,RFAA,1LPZ_CMB,0.3,0.88,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+361,RFAA,1X8X_TYR,0.5,0.8,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+362,RFAA,1T46_STI,0.5925925925925926,0.762962962962963,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+363,RFAA,1IG3_VIB,0.2800000000000001,0.888,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+364,RFAA,1SQ5_PAU,,0.0,,
+365,RFAA,1Q4G_BFL,,0.0,,
+366,RFAA,1OYT_FSN,,0.0,,
+367,RFAA,1UNL_RRC,,0.0,,
+368,RFAA,1U1C_BAU,,0.0,,
+369,RFAA,1K3U_IAD,0.6818181818181818,0.7272727272727273,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+370,RFAA,1G9V_RQ3,,0.0,,
+371,RFAA,1YV3_BIT,0.375,0.85,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+372,RFAA,1IA1_TQ3,,0.0,,
+373,RFAA,1Q1G_MTI,,0.0,,
+374,RFAA,1R1H_BIR,0.3157894736842105,0.8736842105263158,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+375,RFAA,1YVF_PH7,0.20000000000000007,0.9199999999999999,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+376,RFAA,1YQY_915,,0.0,,
+377,RFAA,1HWW_SWA,,0.0,,
+378,RFAA,1T40_ID5,0.3333333333333333,0.8666666666666667,"{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+379,RFAA,1GKC_NFH,0.35000000000000003,0.86,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+380,RFAA,1N1M_A3M,,0.0,,
+381,RFAA,1Z95_198,0.375,0.85,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+382,RFAA,1HP0_AD3,,0.0,,
+383,RFAA,1OF1_SCT,0.45,0.8200000000000001,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+384,RFAA,1SJ0_E4D,,0.0,,
+385,RFAA,1U4D_DBQ,,0.0,,
+386,RFAA,1Q41_IXM,,0.0,,
+387,RFAA,1OWE_675,0.23076923076923078,0.9076923076923077,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+388,RFAA,1OQ5_CEL,0.3888888888888889,0.8444444444444444,"{'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+389,RFAA,1SG0_STL,0.39999999999999997,0.8400000000000001,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+390,RFAA,2BR1_PFP,0.0625,0.975,"{'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+391,RFAA,1UOU_CMU,0.7333333333333334,0.7066666666666667,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+392,RFAA,1TZ8_DES,0.6666666666666666,0.7333333333333334,"{'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}"
+393,RFAA,1R9O_FLP,0.4736842105263159,0.8105263157894737,"{'UNL:ALA:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+394,RFAA,1P2Y_NCT,0.4545454545454545,0.8181818181818182,"{'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+395,RFAA,1V0P_PVB,,0.0,,
+396,RFAA,1XOZ_CIA,0.47058823529411764,0.8117647058823529,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+397,RFAA,1R55_097,0.5294117647058824,0.788235294117647,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 4, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+398,RFAA,1YWR_LI9,0.7142857142857143,0.7142857142857143,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+399,RFAA,1HQ2_PH2,0.05555555555555555,0.9777777777777777,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+400,RFAA,1MZC_BNE,,0.0,,
+401,RFAA,1V4S_MRK,0.32,0.872,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+402,RFAA,1NAV_IH5,0.5294117647058822,0.7882352941176471,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+403,RFAA,1JJE_BYS,,0.0,,
+404,RFAA,1GM8_SOX,,0.0,,
+405,RFAA,1J3J_CP6,,0.0,,
+406,RFAA,1T9B_1CS,,0.0,,
+407,RFAA,1PMN_984,0.375,0.85,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 3, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+408,RFAA,1N2V_BDI,0.23076923076923073,0.9076923076923077,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+409,RFAA,1GPK_HUP,0.23076923076923073,0.9076923076923077,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+410,RFAA,1W1P_GIO,,0.0,,
+411,RFAA,1OF6_DTY,,0.0,,
+412,RFAA,1S3V_TQD,0.14285714285714293,0.9428571428571428,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+413,RFAA,1Y6B_AAX,0.35294117647058826,0.8588235294117648,"{'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+414,RFAA,1L2S_STC,,0.0,,
+415,RFAA,1W2G_THM,0.14285714285714296,0.9428571428571428,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+416,RFAA,1TOW_CRZ,,0.0,,
+417,RFAA,1XM6_5RM,,0.0,,
+418,RFAA,1YGC_905,0.14999999999999997,0.9400000000000001,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+419,RFAA,1R58_AO5,0.47058823529411764,0.8117647058823529,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+420,RFAA,1HNN_SKF,0.5333333333333333,0.7866666666666666,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 5, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+421,RFAA,1HVY_D16,,0.0,,
+422,RFAA,1OPK_P16,0.22727272727272735,0.9090909090909091,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+423,RFAA,1MMV_3AR,,0.0,,
+424,RFAA,1SQN_NDR,,0.0,,
+425,Chai-1-Single-Seq,2BM2_PM2,0.19999999999999998,0.92,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+426,Chai-1-Single-Seq,1XOQ_ROF,0.21428571428571425,0.9142857142857143,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+427,Chai-1-Single-Seq,1M2Z_DEX,0.12499999999999997,0.95,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+428,Chai-1-Single-Seq,1P62_GEO,0.3125,0.875,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+429,Chai-1-Single-Seq,1KE5_LS1,0.20000000000000004,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+430,Chai-1-Single-Seq,1TT1_KAI,0.125,0.95,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+431,Chai-1-Single-Seq,1VCJ_IBA,0.5555555555555556,0.7777777777777778,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+432,Chai-1-Single-Seq,1HWI_115,,0.0,,
+433,Chai-1-Single-Seq,1UML_FR4,0.23076923076923067,0.9076923076923077,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+434,Chai-1-Single-Seq,1JLA_TNK,0.3,0.88,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+435,Chai-1-Single-Seq,1N46_PFA,0.3809523809523809,0.8476190476190477,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+436,Chai-1-Single-Seq,1LRH_NLA,0.26315789473684215,0.8947368421052632,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+437,Chai-1-Single-Seq,1KZK_JE2,0.6428571428571428,0.7428571428571429,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 5, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 6, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+438,Chai-1-Single-Seq,1N2J_PAF,0.0,1.0,"{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+439,Chai-1-Single-Seq,1MEH_MOA,,0.0,,
+440,Chai-1-Single-Seq,2BSM_BSM,0.09523809523809529,0.9619047619047619,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+441,Chai-1-Single-Seq,1V48_HA1,0.1,0.96,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+442,Chai-1-Single-Seq,1L7F_BCZ,0.23529411764705876,0.9058823529411765,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+443,Chai-1-Single-Seq,1JD0_AZM,0.3,0.88,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+444,Chai-1-Single-Seq,1S19_MC9,0.19999999999999996,0.92,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+445,Chai-1-Single-Seq,1LPZ_CMB,0.22727272727272724,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+446,Chai-1-Single-Seq,1X8X_TYR,0.16666666666666657,0.9333333333333333,"{'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+447,Chai-1-Single-Seq,1T46_STI,0.4285714285714286,0.8285714285714285,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+448,Chai-1-Single-Seq,1IG3_VIB,0.2857142857142857,0.8857142857142857,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+449,Chai-1-Single-Seq,1SQ5_PAU,0.375,0.85,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+450,Chai-1-Single-Seq,1Q4G_BFL,0.4444444444444444,0.8222222222222222,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+451,Chai-1-Single-Seq,1OYT_FSN,0.26315789473684215,0.8947368421052632,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+452,Chai-1-Single-Seq,1UNL_RRC,0.368421052631579,0.8526315789473684,"{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+453,Chai-1-Single-Seq,1U1C_BAU,0.2777777777777778,0.8888888888888888,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+454,Chai-1-Single-Seq,1K3U_IAD,0.09523809523809518,0.9619047619047619,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+455,Chai-1-Single-Seq,1G9V_RQ3,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+456,Chai-1-Single-Seq,1YV3_BIT,0.5416666666666666,0.7833333333333333,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+457,Chai-1-Single-Seq,1IA1_TQ3,0.2,0.92,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+458,Chai-1-Single-Seq,1Q1G_MTI,,0.0,,
+459,Chai-1-Single-Seq,1R1H_BIR,0.34999999999999987,0.8600000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+460,Chai-1-Single-Seq,1YVF_PH7,0.20833333333333326,0.9166666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+461,Chai-1-Single-Seq,1YQY_915,0.09999999999999998,0.96,"{'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+462,Chai-1-Single-Seq,1HWW_SWA,,0.0,,
+463,Chai-1-Single-Seq,1T40_ID5,0.33333333333333337,0.8666666666666667,"{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+464,Chai-1-Single-Seq,1GKC_NFH,0.21052631578947367,0.9157894736842105,"{'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+465,Chai-1-Single-Seq,1N1M_A3M,,0.0,,
+466,Chai-1-Single-Seq,1Z95_198,0.1333333333333333,0.9466666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+467,Chai-1-Single-Seq,1HP0_AD3,0.0,1.0,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+468,Chai-1-Single-Seq,1OF1_SCT,0.050000000000000044,0.98,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+469,Chai-1-Single-Seq,1SJ0_E4D,0.04347826086956519,0.9826086956521739,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+470,Chai-1-Single-Seq,1U4D_DBQ,0.2857142857142858,0.8857142857142857,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+471,Chai-1-Single-Seq,1Q41_IXM,0.11764705882352942,0.9529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+472,Chai-1-Single-Seq,1OWE_675,0.19999999999999998,0.92,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+473,Chai-1-Single-Seq,1OQ5_CEL,0.14285714285714285,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+474,Chai-1-Single-Seq,1SG0_STL,0.5,0.8,"{'UNL:ASN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+475,Chai-1-Single-Seq,2BR1_PFP,0.06666666666666665,0.9733333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+476,Chai-1-Single-Seq,1UOU_CMU,0.15789473684210525,0.9368421052631579,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+477,Chai-1-Single-Seq,1TZ8_DES,0.2727272727272726,0.890909090909091,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}"
+478,Chai-1-Single-Seq,1R9O_FLP,0.22222222222222215,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+479,Chai-1-Single-Seq,1P2Y_NCT,0.16666666666666663,0.9333333333333333,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+480,Chai-1-Single-Seq,1V0P_PVB,0.2777777777777778,0.8888888888888888,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+481,Chai-1-Single-Seq,1XOZ_CIA,0.0625,0.975,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+482,Chai-1-Single-Seq,1R55_097,0.06666666666666665,0.9733333333333334,"{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+483,Chai-1-Single-Seq,1YWR_LI9,0.045454545454545456,0.9818181818181818,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+484,Chai-1-Single-Seq,1HQ2_PH2,0.0,1.0,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+485,Chai-1-Single-Seq,1MZC_BNE,0.2857142857142857,0.8857142857142857,"{'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+486,Chai-1-Single-Seq,1V4S_MRK,0.20833333333333326,0.9166666666666667,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+487,Chai-1-Single-Seq,1NAV_IH5,0.2500000000000001,0.8999999999999999,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+488,Chai-1-Single-Seq,1JJE_BYS,0.1578947368421053,0.9368421052631579,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+489,Chai-1-Single-Seq,1GM8_SOX,0.21428571428571433,0.9142857142857143,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2}"
+490,Chai-1-Single-Seq,1J3J_CP6,0.23529411764705882,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+491,Chai-1-Single-Seq,1T9B_1CS,0.23529411764705882,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+492,Chai-1-Single-Seq,1PMN_984,0.4705882352941177,0.8117647058823529,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+493,Chai-1-Single-Seq,1N2V_BDI,0.26666666666666666,0.8933333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+494,Chai-1-Single-Seq,1GPK_HUP,0.4444444444444444,0.8222222222222222,"{'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+495,Chai-1-Single-Seq,1W1P_GIO,1.0,0.6,"{'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+496,Chai-1-Single-Seq,1OF6_DTY,,0.0,,
+497,Chai-1-Single-Seq,1S3V_TQD,0.4375,0.825,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+498,Chai-1-Single-Seq,1Y6B_AAX,0.1428571428571428,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+499,Chai-1-Single-Seq,1L2S_STC,0.26666666666666666,0.8933333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+500,Chai-1-Single-Seq,1W2G_THM,0.0,1.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+501,Chai-1-Single-Seq,1TOW_CRZ,0.1333333333333333,0.9466666666666667,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+502,Chai-1-Single-Seq,1XM6_5RM,0.25,0.9,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+503,Chai-1-Single-Seq,1YGC_905,0.1875,0.925,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+504,Chai-1-Single-Seq,1R58_AO5,0.1666666666666667,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+505,Chai-1-Single-Seq,1HNN_SKF,0.4166666666666667,0.8333333333333333,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+506,Chai-1-Single-Seq,1HVY_D16,0.1538461538461539,0.9384615384615385,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:UMP:Hydrophobic': 1, 'UNL:UMP:VdWContact': 1}"
+507,Chai-1-Single-Seq,1OPK_P16,,0.0,,
+508,Chai-1-Single-Seq,1MMV_3AR,0.2631578947368421,0.8947368421052632,"{'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+509,Chai-1-Single-Seq,1SQN_NDR,0.1875,0.925,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+510,Chai-1,2BM2_PM2,0.29411764705882354,0.8823529411764706,"{'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+511,Chai-1,1XOQ_ROF,0.20000000000000007,0.9199999999999999,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+512,Chai-1,1M2Z_DEX,0.2857142857142857,0.8857142857142857,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+513,Chai-1,1P62_GEO,0.23529411764705882,0.9058823529411765,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+514,Chai-1,1KE5_LS1,0.11111111111111113,0.9555555555555555,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+515,Chai-1,1TT1_KAI,0.17647058823529413,0.9294117647058824,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+516,Chai-1,1VCJ_IBA,0.11764705882352944,0.9529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+517,Chai-1,1HWI_115,0.1739130434782609,0.9304347826086956,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+518,Chai-1,1UML_FR4,0.28571428571428575,0.8857142857142857,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+519,Chai-1,1JLA_TNK,0.0714285714285714,0.9714285714285714,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+520,Chai-1,1N46_PFA,0.33333333333333326,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+521,Chai-1,1LRH_NLA,0.8666666666666667,0.6533333333333333,"{'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+522,Chai-1,1KZK_JE2,0.3846153846153847,0.8461538461538461,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+523,Chai-1,1N2J_PAF,0.3846153846153846,0.8461538461538461,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+524,Chai-1,1MEH_MOA,0.18181818181818174,0.9272727272727272,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+525,Chai-1,2BSM_BSM,0.09523809523809523,0.9619047619047619,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+526,Chai-1,1V48_HA1,0.10526315789473684,0.9578947368421052,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+527,Chai-1,1L7F_BCZ,0.357142857142857,0.8571428571428572,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+528,Chai-1,1JD0_AZM,0.09090909090909091,0.9636363636363636,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+529,Chai-1,1S19_MC9,0.3333333333333334,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+530,Chai-1,1LPZ_CMB,0.10526315789473689,0.9578947368421052,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+531,Chai-1,1X8X_TYR,0.09090909090909083,0.9636363636363636,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+532,Chai-1,1T46_STI,0.4285714285714286,0.8285714285714285,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+533,Chai-1,1IG3_VIB,0.23076923076923073,0.9076923076923077,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+534,Chai-1,1SQ5_PAU,0.29411764705882354,0.8823529411764706,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+535,Chai-1,1Q4G_BFL,0.2666666666666668,0.8933333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+536,Chai-1,1OYT_FSN,0.10526315789473684,0.9578947368421052,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+537,Chai-1,1UNL_RRC,0.09999999999999998,0.96,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+538,Chai-1,1U1C_BAU,0.3125,0.875,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+539,Chai-1,1K3U_IAD,0.15151515151515155,0.9393939393939393,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+540,Chai-1,1G9V_RQ3,0.1333333333333333,0.9466666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+541,Chai-1,1YV3_BIT,,0.0,,
+542,Chai-1,1IA1_TQ3,0.07692307692307693,0.9692307692307692,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+543,Chai-1,1Q1G_MTI,0.05555555555555555,0.9777777777777777,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+544,Chai-1,1R1H_BIR,0.15789473684210525,0.9368421052631579,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+545,Chai-1,1YVF_PH7,0.11111111111111116,0.9555555555555555,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+546,Chai-1,1YQY_915,0.1578947368421053,0.9368421052631579,"{'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+547,Chai-1,1HWW_SWA,0.2727272727272728,0.8909090909090909,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+548,Chai-1,1T40_ID5,0.33333333333333337,0.8666666666666667,"{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+549,Chai-1,1GKC_NFH,0.21052631578947362,0.9157894736842106,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+550,Chai-1,1N1M_A3M,,0.0,,
+551,Chai-1,1Z95_198,0.06666666666666667,0.9733333333333334,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+552,Chai-1,1HP0_AD3,0.23076923076923078,0.9076923076923077,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+553,Chai-1,1OF1_SCT,0.23529411764705876,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+554,Chai-1,1SJ0_E4D,0.1200000000000001,0.952,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+555,Chai-1,1U4D_DBQ,0.07692307692307698,0.9692307692307692,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+556,Chai-1,1Q41_IXM,0.06666666666666667,0.9733333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+557,Chai-1,1OWE_675,0.3,0.88,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+558,Chai-1,1OQ5_CEL,0.09999999999999992,0.9600000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+559,Chai-1,1SG0_STL,0.375,0.85,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+560,Chai-1,2BR1_PFP,0.13333333333333336,0.9466666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+561,Chai-1,1UOU_CMU,0.0,1.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+562,Chai-1,1TZ8_DES,0.29999999999999993,0.88,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}"
+563,Chai-1,1R9O_FLP,0.3529411764705883,0.8588235294117647,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+564,Chai-1,1P2Y_NCT,0.25000000000000006,0.9,"{'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+565,Chai-1,1V0P_PVB,0.5499999999999999,0.78,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+566,Chai-1,1XOZ_CIA,0.125,0.95,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+567,Chai-1,1R55_097,0.1333333333333333,0.9466666666666667,"{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+568,Chai-1,1YWR_LI9,0.04761904761904756,0.980952380952381,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+569,Chai-1,1HQ2_PH2,0.11764705882352942,0.9529411764705882,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+570,Chai-1,1MZC_BNE,0.1538461538461539,0.9384615384615385,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+571,Chai-1,1V4S_MRK,0.04761904761904767,0.9809523809523809,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+572,Chai-1,1NAV_IH5,0.17647058823529416,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+573,Chai-1,1JJE_BYS,0.26315789473684215,0.8947368421052632,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+574,Chai-1,1GM8_SOX,0.44444444444444453,0.8222222222222222,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2}"
+575,Chai-1,1J3J_CP6,0.2857142857142857,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+576,Chai-1,1T9B_1CS,0.13333333333333333,0.9466666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+577,Chai-1,1PMN_984,0.3125,0.875,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+578,Chai-1,1N2V_BDI,0.15384615384615385,0.9384615384615385,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+579,Chai-1,1GPK_HUP,0.5,0.8,"{'UNL:GLY:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+580,Chai-1,1W1P_GIO,0.5999999999999999,0.76,"{'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+581,Chai-1,1OF6_DTY,,0.0,,
+582,Chai-1,1S3V_TQD,0.30769230769230776,0.8769230769230769,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+583,Chai-1,1Y6B_AAX,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+584,Chai-1,1L2S_STC,0.2,0.92,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+585,Chai-1,1W2G_THM,0.1538461538461539,0.9384615384615385,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+586,Chai-1,1TOW_CRZ,0.19999999999999996,0.92,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+587,Chai-1,1XM6_5RM,0.21428571428571425,0.9142857142857143,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+588,Chai-1,1YGC_905,0.17647058823529405,0.9294117647058824,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+589,Chai-1,1R58_AO5,0.23529411764705888,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+590,Chai-1,1HNN_SKF,0.3846153846153846,0.8461538461538461,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+591,Chai-1,1HVY_D16,0.22727272727272732,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:UMP:Hydrophobic': 1, 'UNL:UMP:VdWContact': 1}"
+592,Chai-1,1OPK_P16,0.16666666666666666,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+593,Chai-1,1MMV_3AR,0.0,1.0,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+594,Chai-1,1SQN_NDR,0.1333333333333333,0.9466666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+595,Boltz-1-Single-Seq,2BM2_PM2,,0.0,,
+596,Boltz-1-Single-Seq,1XOQ_ROF,,0.0,,
+597,Boltz-1-Single-Seq,1M2Z_DEX,0.17391304347826086,0.9304347826086956,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+598,Boltz-1-Single-Seq,1P62_GEO,0.29411764705882354,0.8823529411764706,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+599,Boltz-1-Single-Seq,1KE5_LS1,0.0,1.0,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+600,Boltz-1-Single-Seq,1TT1_KAI,0.11111111111111102,0.9555555555555556,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+601,Boltz-1-Single-Seq,1VCJ_IBA,0.3125,0.875,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+602,Boltz-1-Single-Seq,1HWI_115,,0.0,,
+603,Boltz-1-Single-Seq,1UML_FR4,0.21428571428571422,0.9142857142857144,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+604,Boltz-1-Single-Seq,1JLA_TNK,0.26315789473684204,0.8947368421052632,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+605,Boltz-1-Single-Seq,1N46_PFA,0.18181818181818182,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+606,Boltz-1-Single-Seq,1LRH_NLA,,0.0,,
+607,Boltz-1-Single-Seq,1KZK_JE2,0.6153846153846154,0.7538461538461538,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+608,Boltz-1-Single-Seq,1N2J_PAF,0.1666666666666667,0.9333333333333333,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+609,Boltz-1-Single-Seq,1MEH_MOA,0.24999999999999994,0.9,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+610,Boltz-1-Single-Seq,2BSM_BSM,0.047619047619047616,0.9809523809523809,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+611,Boltz-1-Single-Seq,1V48_HA1,0.047619047619047616,0.9809523809523809,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+612,Boltz-1-Single-Seq,1L7F_BCZ,0.17647058823529416,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+613,Boltz-1-Single-Seq,1JD0_AZM,0.2000000000000001,0.9199999999999999,"{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+614,Boltz-1-Single-Seq,1S19_MC9,0.2857142857142857,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+615,Boltz-1-Single-Seq,1LPZ_CMB,,0.0,,
+616,Boltz-1-Single-Seq,1X8X_TYR,0.16666666666666657,0.9333333333333333,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+617,Boltz-1-Single-Seq,1T46_STI,0.08333333333333337,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+618,Boltz-1-Single-Seq,1IG3_VIB,0.1538461538461538,0.9384615384615385,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+619,Boltz-1-Single-Seq,1SQ5_PAU,,0.0,,
+620,Boltz-1-Single-Seq,1Q4G_BFL,,0.0,,
+621,Boltz-1-Single-Seq,1OYT_FSN,0.1666666666666666,0.9333333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+622,Boltz-1-Single-Seq,1UNL_RRC,,0.0,,
+623,Boltz-1-Single-Seq,1U1C_BAU,,0.0,,
+624,Boltz-1-Single-Seq,1K3U_IAD,0.4,0.84,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+625,Boltz-1-Single-Seq,1G9V_RQ3,,0.0,,
+626,Boltz-1-Single-Seq,1YV3_BIT,0.30000000000000004,0.88,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+627,Boltz-1-Single-Seq,1IA1_TQ3,0.07142857142857142,0.9714285714285714,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+628,Boltz-1-Single-Seq,1Q1G_MTI,,0.0,,
+629,Boltz-1-Single-Seq,1R1H_BIR,0.1578947368421053,0.9368421052631579,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+630,Boltz-1-Single-Seq,1YVF_PH7,0.18181818181818182,0.9272727272727272,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+631,Boltz-1-Single-Seq,1YQY_915,0.09090909090909091,0.9636363636363636,"{'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+632,Boltz-1-Single-Seq,1HWW_SWA,0.16666666666666669,0.9333333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+633,Boltz-1-Single-Seq,1T40_ID5,0.38888888888888895,0.8444444444444444,"{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+634,Boltz-1-Single-Seq,1GKC_NFH,,0.0,,
+635,Boltz-1-Single-Seq,1N1M_A3M,,0.0,,
+636,Boltz-1-Single-Seq,1Z95_198,0.16666666666666669,0.9333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+637,Boltz-1-Single-Seq,1HP0_AD3,0.0,1.0,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+638,Boltz-1-Single-Seq,1OF1_SCT,0.10000000000000006,0.96,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+639,Boltz-1-Single-Seq,1SJ0_E4D,0.12499999999999994,0.9500000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+640,Boltz-1-Single-Seq,1U4D_DBQ,0.08333333333333326,0.9666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+641,Boltz-1-Single-Seq,1Q41_IXM,0.11764705882352944,0.9529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+642,Boltz-1-Single-Seq,1OWE_675,0.39999999999999997,0.8400000000000001,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+643,Boltz-1-Single-Seq,1OQ5_CEL,0.09523809523809518,0.9619047619047619,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+644,Boltz-1-Single-Seq,1SG0_STL,0.0,1.0,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+645,Boltz-1-Single-Seq,2BR1_PFP,0.15384615384615385,0.9384615384615385,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+646,Boltz-1-Single-Seq,1UOU_CMU,0.3571428571428571,0.8571428571428572,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+647,Boltz-1-Single-Seq,1TZ8_DES,0.30000000000000004,0.88,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}"
+648,Boltz-1-Single-Seq,1R9O_FLP,,0.0,,
+649,Boltz-1-Single-Seq,1P2Y_NCT,,0.0,,
+650,Boltz-1-Single-Seq,1V0P_PVB,0.44999999999999996,0.8200000000000001,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+651,Boltz-1-Single-Seq,1XOZ_CIA,0.1875,0.925,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+652,Boltz-1-Single-Seq,1R55_097,0.19999999999999996,0.92,"{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+653,Boltz-1-Single-Seq,1YWR_LI9,0.19047619047619047,0.9238095238095239,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+654,Boltz-1-Single-Seq,1HQ2_PH2,0.0,1.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+655,Boltz-1-Single-Seq,1MZC_BNE,,0.0,,
+656,Boltz-1-Single-Seq,1V4S_MRK,0.1578947368421052,0.9368421052631579,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+657,Boltz-1-Single-Seq,1NAV_IH5,0.3000000000000001,0.88,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+658,Boltz-1-Single-Seq,1JJE_BYS,0.5294117647058824,0.788235294117647,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+659,Boltz-1-Single-Seq,1GM8_SOX,,0.0,,
+660,Boltz-1-Single-Seq,1J3J_CP6,,0.0,,
+661,Boltz-1-Single-Seq,1T9B_1CS,,0.0,,
+662,Boltz-1-Single-Seq,1PMN_984,0.4444444444444445,0.8222222222222222,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+663,Boltz-1-Single-Seq,1N2V_BDI,0.2857142857142857,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+664,Boltz-1-Single-Seq,1GPK_HUP,0.4166666666666667,0.8333333333333333,"{'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+665,Boltz-1-Single-Seq,1W1P_GIO,,0.0,,
+666,Boltz-1-Single-Seq,1OF6_DTY,,0.0,,
+667,Boltz-1-Single-Seq,1S3V_TQD,0.4285714285714286,0.8285714285714285,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+668,Boltz-1-Single-Seq,1Y6B_AAX,0.22222222222222227,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+669,Boltz-1-Single-Seq,1L2S_STC,0.16666666666666669,0.9333333333333333,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+670,Boltz-1-Single-Seq,1W2G_THM,0.07692307692307693,0.9692307692307692,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+671,Boltz-1-Single-Seq,1TOW_CRZ,0.17647058823529413,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+672,Boltz-1-Single-Seq,1XM6_5RM,0.35294117647058815,0.8588235294117648,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+673,Boltz-1-Single-Seq,1YGC_905,,0.0,,
+674,Boltz-1-Single-Seq,1R58_AO5,0.26666666666666666,0.8933333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+675,Boltz-1-Single-Seq,1HNN_SKF,0.0,1.0,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+676,Boltz-1-Single-Seq,1HVY_D16,,0.0,,
+677,Boltz-1-Single-Seq,1OPK_P16,0.28571428571428575,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+678,Boltz-1-Single-Seq,1MMV_3AR,,0.0,,
+679,Boltz-1-Single-Seq,1SQN_NDR,0.25,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+680,Boltz-1,2BM2_PM2,,0.0,,
+681,Boltz-1,1XOQ_ROF,,0.0,,
+682,Boltz-1,1M2Z_DEX,0.1739130434782608,0.9304347826086957,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+683,Boltz-1,1P62_GEO,0.33333333333333326,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+684,Boltz-1,1KE5_LS1,0.05555555555555558,0.9777777777777777,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+685,Boltz-1,1TT1_KAI,0.15789473684210525,0.9368421052631579,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+686,Boltz-1,1VCJ_IBA,0.15789473684210537,0.9368421052631578,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+687,Boltz-1,1HWI_115,,0.0,,
+688,Boltz-1,1UML_FR4,0.26666666666666666,0.8933333333333333,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+689,Boltz-1,1JLA_TNK,0.3684210526315789,0.8526315789473684,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+690,Boltz-1,1N46_PFA,0.28571428571428564,0.8857142857142858,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+691,Boltz-1,1LRH_NLA,,0.0,,
+692,Boltz-1,1KZK_JE2,0.49999999999999994,0.8,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+693,Boltz-1,1N2J_PAF,0.18181818181818177,0.9272727272727272,"{'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+694,Boltz-1,1MEH_MOA,0.07692307692307698,0.9692307692307692,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+695,Boltz-1,2BSM_BSM,0.09999999999999994,0.9600000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+696,Boltz-1,1V48_HA1,0.04761904761904767,0.9809523809523809,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+697,Boltz-1,1L7F_BCZ,0.13333333333333341,0.9466666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+698,Boltz-1,1JD0_AZM,0.2000000000000001,0.9199999999999999,"{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+699,Boltz-1,1S19_MC9,0.2380952380952382,0.9047619047619048,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+700,Boltz-1,1LPZ_CMB,,0.0,,
+701,Boltz-1,1X8X_TYR,0.0,1.0,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+702,Boltz-1,1T46_STI,0.12500000000000003,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+703,Boltz-1,1IG3_VIB,0.1538461538461538,0.9384615384615385,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+704,Boltz-1,1SQ5_PAU,,0.0,,
+705,Boltz-1,1Q4G_BFL,,0.0,,
+706,Boltz-1,1OYT_FSN,0.2631578947368421,0.8947368421052632,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+707,Boltz-1,1UNL_RRC,,0.0,,
+708,Boltz-1,1U1C_BAU,,0.0,,
+709,Boltz-1,1K3U_IAD,0.23809523809523814,0.9047619047619048,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+710,Boltz-1,1G9V_RQ3,,0.0,,
+711,Boltz-1,1YV3_BIT,0.1904761904761904,0.9238095238095239,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+712,Boltz-1,1IA1_TQ3,0.07142857142857142,0.9714285714285714,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+713,Boltz-1,1Q1G_MTI,,0.0,,
+714,Boltz-1,1R1H_BIR,0.15000000000000002,0.94,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+715,Boltz-1,1YVF_PH7,0.17391304347826086,0.9304347826086956,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+716,Boltz-1,1YQY_915,0.21739130434782608,0.9130434782608696,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+717,Boltz-1,1HWW_SWA,0.15384615384615385,0.9384615384615385,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+718,Boltz-1,1T40_ID5,0.2631578947368421,0.8947368421052632,"{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+719,Boltz-1,1GKC_NFH,,0.0,,
+720,Boltz-1,1N1M_A3M,,0.0,,
+721,Boltz-1,1Z95_198,0.11764705882352942,0.9529411764705882,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+722,Boltz-1,1HP0_AD3,0.09090909090909091,0.9636363636363636,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+723,Boltz-1,1OF1_SCT,0.2222222222222223,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+724,Boltz-1,1SJ0_E4D,0.12000000000000008,0.952,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+725,Boltz-1,1U4D_DBQ,0.08333333333333326,0.9666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+726,Boltz-1,1Q41_IXM,0.0625,0.975,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+727,Boltz-1,1OWE_675,0.30000000000000004,0.88,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+728,Boltz-1,1OQ5_CEL,0.14999999999999997,0.9400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+729,Boltz-1,1SG0_STL,0.4444444444444445,0.8222222222222222,"{'UNL:GLN:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+730,Boltz-1,2BR1_PFP,0.07692307692307693,0.9692307692307692,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+731,Boltz-1,1UOU_CMU,0.3571428571428571,0.8571428571428572,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+732,Boltz-1,1TZ8_DES,0.24999999999999992,0.9,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}"
+733,Boltz-1,1R9O_FLP,,0.0,,
+734,Boltz-1,1P2Y_NCT,,0.0,,
+735,Boltz-1,1V0P_PVB,0.3157894736842105,0.8736842105263158,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+736,Boltz-1,1XOZ_CIA,0.0625,0.975,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+737,Boltz-1,1R55_097,0.1333333333333333,0.9466666666666667,"{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+738,Boltz-1,1YWR_LI9,0.09523809523809523,0.9619047619047619,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+739,Boltz-1,1HQ2_PH2,0.0,1.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+740,Boltz-1,1MZC_BNE,,0.0,,
+741,Boltz-1,1V4S_MRK,0.05000000000000002,0.98,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+742,Boltz-1,1NAV_IH5,0.15789473684210525,0.9368421052631579,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+743,Boltz-1,1JJE_BYS,0.5000000000000001,0.7999999999999999,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+744,Boltz-1,1GM8_SOX,,0.0,,
+745,Boltz-1,1J3J_CP6,,0.0,,
+746,Boltz-1,1T9B_1CS,,0.0,,
+747,Boltz-1,1PMN_984,0.375,0.85,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+748,Boltz-1,1N2V_BDI,0.21428571428571427,0.9142857142857143,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+749,Boltz-1,1GPK_HUP,0.36363636363636354,0.8545454545454546,"{'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+750,Boltz-1,1W1P_GIO,,0.0,,
+751,Boltz-1,1OF6_DTY,,0.0,,
+752,Boltz-1,1S3V_TQD,0.2857142857142858,0.8857142857142857,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+753,Boltz-1,1Y6B_AAX,0.2941176470588236,0.8823529411764706,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+754,Boltz-1,1L2S_STC,0.125,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+755,Boltz-1,1W2G_THM,0.14285714285714285,0.9428571428571428,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+756,Boltz-1,1TOW_CRZ,0.23529411764705885,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+757,Boltz-1,1XM6_5RM,0.21428571428571422,0.9142857142857144,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+758,Boltz-1,1YGC_905,,0.0,,
+759,Boltz-1,1R58_AO5,0.17647058823529405,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+760,Boltz-1,1HNN_SKF,0.07142857142857142,0.9714285714285714,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+761,Boltz-1,1HVY_D16,,0.0,,
+762,Boltz-1,1OPK_P16,0.38095238095238093,0.8476190476190476,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+763,Boltz-1,1MMV_3AR,,0.0,,
+764,Boltz-1,1SQN_NDR,0.125,0.95,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+765,AF3-Single-Seq,2BM2_PM2,0.4583333333333335,0.8166666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+766,AF3-Single-Seq,1XOQ_ROF,,0.0,,
+767,AF3-Single-Seq,1M2Z_DEX,0.8260869565217392,0.6695652173913043,"{'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+768,AF3-Single-Seq,1P62_GEO,0.27777777777777785,0.8888888888888888,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+769,AF3-Single-Seq,1KE5_LS1,0.7619047619047619,0.6952380952380952,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+770,AF3-Single-Seq,1TT1_KAI,0.8235294117647058,0.6705882352941177,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+771,AF3-Single-Seq,1VCJ_IBA,0.3333333333333334,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+772,AF3-Single-Seq,1HWI_115,0.6,0.76,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+773,AF3-Single-Seq,1UML_FR4,0.4583333333333335,0.8166666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+774,AF3-Single-Seq,1JLA_TNK,0.12,0.952,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+775,AF3-Single-Seq,1N46_PFA,1.4090909090909092,0.4363636363636363,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:MET:Hydrophobic': 8, 'UNL:MET:VdWContact': 6, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+776,AF3-Single-Seq,1LRH_NLA,,0.0,,
+777,AF3-Single-Seq,1KZK_JE2,0.44999999999999996,0.8200000000000001,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:ILE:Hydrophobic': 6, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+778,AF3-Single-Seq,1N2J_PAF,0.75,0.7,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+779,AF3-Single-Seq,1MEH_MOA,0.125,0.95,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+780,AF3-Single-Seq,2BSM_BSM,0.44,0.8240000000000001,"{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+781,AF3-Single-Seq,1V48_HA1,0.32,0.872,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+782,AF3-Single-Seq,1L7F_BCZ,0.625,0.75,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+783,AF3-Single-Seq,1JD0_AZM,1.0,0.6,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+784,AF3-Single-Seq,1S19_MC9,0.2592592592592594,0.8962962962962963,"{'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+785,AF3-Single-Seq,1LPZ_CMB,0.3571428571428571,0.8571428571428572,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+786,AF3-Single-Seq,1X8X_TYR,0.5625,0.775,"{'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+787,AF3-Single-Seq,1T46_STI,0.36666666666666664,0.8533333333333333,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+788,AF3-Single-Seq,1IG3_VIB,0.4705882352941177,0.8117647058823529,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+789,AF3-Single-Seq,1SQ5_PAU,0.7142857142857143,0.7142857142857143,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+790,AF3-Single-Seq,1Q4G_BFL,1.5000000000000002,0.3999999999999999,{},"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+791,AF3-Single-Seq,1OYT_FSN,0.23076923076923078,0.9076923076923077,"{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+792,AF3-Single-Seq,1UNL_RRC,0.44,0.8240000000000001,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+793,AF3-Single-Seq,1U1C_BAU,0.6842105263157894,0.7263157894736842,"{'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+794,AF3-Single-Seq,1K3U_IAD,0.4615384615384616,0.8153846153846154,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+795,AF3-Single-Seq,1G9V_RQ3,0.24999999999999994,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+796,AF3-Single-Seq,1YV3_BIT,,0.0,,
+797,AF3-Single-Seq,1IA1_TQ3,0.31578947368421056,0.8736842105263158,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+798,AF3-Single-Seq,1Q1G_MTI,0.75,0.7,"{'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LIG:HBDonor': 1, 'UNL:LIG:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+799,AF3-Single-Seq,1R1H_BIR,0.1785714285714286,0.9285714285714286,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+800,AF3-Single-Seq,1YVF_PH7,0.34482758620689646,0.8620689655172414,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+801,AF3-Single-Seq,1YQY_915,0.4210526315789473,0.8315789473684211,"{'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+802,AF3-Single-Seq,1HWW_SWA,0.5625,0.775,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+803,AF3-Single-Seq,1T40_ID5,0.16000000000000014,0.9359999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+804,AF3-Single-Seq,1GKC_NFH,0.8571428571428571,0.6571428571428571,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+805,AF3-Single-Seq,1N1M_A3M,1.7,0.32000000000000006,{},"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2}"
+806,AF3-Single-Seq,1Z95_198,0.45000000000000007,0.82,"{'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+807,AF3-Single-Seq,1HP0_AD3,0.5384615384615385,0.7846153846153846,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+808,AF3-Single-Seq,1OF1_SCT,0.8500000000000001,0.6599999999999999,"{'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+809,AF3-Single-Seq,1SJ0_E4D,0.4814814814814818,0.8074074074074074,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+810,AF3-Single-Seq,1U4D_DBQ,0.23529411764705882,0.9058823529411765,"{'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+811,AF3-Single-Seq,1Q41_IXM,0.6470588235294118,0.7411764705882353,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+812,AF3-Single-Seq,1OWE_675,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+813,AF3-Single-Seq,1OQ5_CEL,0.48,0.808,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+814,AF3-Single-Seq,1SG0_STL,0.4444444444444444,0.8222222222222222,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+815,AF3-Single-Seq,2BR1_PFP,0.34615384615384615,0.8615384615384616,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+816,AF3-Single-Seq,1UOU_CMU,0.3684210526315789,0.8526315789473684,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+817,AF3-Single-Seq,1TZ8_DES,1.2000000000000002,0.5199999999999999,"{'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 4, 'UNL:THR:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}"
+818,AF3-Single-Seq,1R9O_FLP,0.12499999999999989,0.9500000000000001,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+819,AF3-Single-Seq,1P2Y_NCT,0.05882352941176472,0.9764705882352941,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+820,AF3-Single-Seq,1V0P_PVB,0.48148148148148145,0.8074074074074074,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+821,AF3-Single-Seq,1XOZ_CIA,0.35,0.86,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+822,AF3-Single-Seq,1R55_097,0.3684210526315789,0.8526315789473684,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+823,AF3-Single-Seq,1YWR_LI9,0.5555555555555555,0.7777777777777778,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+824,AF3-Single-Seq,1HQ2_PH2,0.14999999999999997,0.9400000000000001,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+825,AF3-Single-Seq,1MZC_BNE,0.6923076923076923,0.7230769230769231,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+826,AF3-Single-Seq,1V4S_MRK,0.09999999999999998,0.96,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+827,AF3-Single-Seq,1NAV_IH5,0.30434782608695665,0.8782608695652173,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+828,AF3-Single-Seq,1JJE_BYS,0.16666666666666663,0.9333333333333333,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+829,AF3-Single-Seq,1GM8_SOX,0.3478260869565218,0.8608695652173912,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2}"
+830,AF3-Single-Seq,1J3J_CP6,0.10000000000000003,0.96,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+831,AF3-Single-Seq,1T9B_1CS,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+832,AF3-Single-Seq,1PMN_984,0.42105263157894735,0.8315789473684211,"{'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+833,AF3-Single-Seq,1N2V_BDI,0.39999999999999997,0.8400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+834,AF3-Single-Seq,1GPK_HUP,0.4666666666666667,0.8133333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+835,AF3-Single-Seq,1W1P_GIO,1.0833333333333333,0.5666666666666667,{'UNL:TRP:VdWContact': 1},"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+836,AF3-Single-Seq,1OF6_DTY,,0.0,,
+837,AF3-Single-Seq,1S3V_TQD,0.35294117647058826,0.8588235294117648,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+838,AF3-Single-Seq,1Y6B_AAX,0.7142857142857144,0.7142857142857142,"{'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+839,AF3-Single-Seq,1L2S_STC,0.16666666666666669,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+840,AF3-Single-Seq,1W2G_THM,0.3888888888888889,0.8444444444444444,"{'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+841,AF3-Single-Seq,1TOW_CRZ,0.1875,0.925,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+842,AF3-Single-Seq,1XM6_5RM,0.16666666666666669,0.9333333333333333,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+843,AF3-Single-Seq,1YGC_905,0.1538461538461538,0.9384615384615385,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+844,AF3-Single-Seq,1R58_AO5,0.1739130434782608,0.9304347826086957,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+845,AF3-Single-Seq,1HNN_SKF,0.42857142857142855,0.8285714285714285,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+846,AF3-Single-Seq,1HVY_D16,0.23333333333333334,0.9066666666666666,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:UMP:Hydrophobic': 1, 'UNL:UMP:VdWContact': 1}"
+847,AF3-Single-Seq,1OPK_P16,0.16666666666666669,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+848,AF3-Single-Seq,1MMV_3AR,0.6875,0.725,"{'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+849,AF3-Single-Seq,1SQN_NDR,0.49999999999999994,0.8,"{'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+850,AF3,2BM2_PM2,0.15384615384615385,0.9384615384615385,"{'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+851,AF3,1XOQ_ROF,,0.0,,
+852,AF3,1M2Z_DEX,0.22727272727272735,0.9090909090909091,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+853,AF3,1P62_GEO,0.2,0.92,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+854,AF3,1KE5_LS1,0.0,1.0,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+855,AF3,1TT1_KAI,0.16666666666666657,0.9333333333333333,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+856,AF3,1VCJ_IBA,0.05882352941176472,0.9764705882352941,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+857,AF3,1HWI_115,0.08333333333333334,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+858,AF3,1UML_FR4,0.15384615384615385,0.9384615384615385,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+859,AF3,1JLA_TNK,0.1666666666666667,0.9333333333333333,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+860,AF3,1N46_PFA,0.23809523809523803,0.9047619047619048,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+861,AF3,1LRH_NLA,,0.0,,
+862,AF3,1KZK_JE2,0.5384615384615385,0.7846153846153846,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 5, 'UNL:ILE:Hydrophobic': 6, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+863,AF3,1N2J_PAF,0.2000000000000001,0.9199999999999999,"{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+864,AF3,1MEH_MOA,0.18181818181818185,0.9272727272727272,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+865,AF3,2BSM_BSM,0.15789473684210525,0.9368421052631579,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+866,AF3,1V48_HA1,0.04545454545454547,0.9818181818181818,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+867,AF3,1L7F_BCZ,0.1428571428571428,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+868,AF3,1JD0_AZM,0.30000000000000004,0.88,"{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+869,AF3,1S19_MC9,0.21052631578947367,0.9157894736842105,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+870,AF3,1LPZ_CMB,0.10526315789473678,0.9578947368421052,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+871,AF3,1X8X_TYR,0.16666666666666657,0.9333333333333333,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+872,AF3,1T46_STI,0.2083333333333334,0.9166666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+873,AF3,1IG3_VIB,0.18181818181818185,0.9272727272727272,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+874,AF3,1SQ5_PAU,0.21428571428571427,0.9142857142857143,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+875,AF3,1Q4G_BFL,1.1428571428571428,0.5428571428571429,"{'UNL:GLY:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+876,AF3,1OYT_FSN,0.26315789473684215,0.8947368421052632,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+877,AF3,1UNL_RRC,0.3636363636363637,0.8545454545454545,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+878,AF3,1U1C_BAU,0.1875,0.925,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+879,AF3,1K3U_IAD,0.38095238095238093,0.8476190476190476,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+880,AF3,1G9V_RQ3,0.2631578947368421,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+881,AF3,1YV3_BIT,,0.0,,
+882,AF3,1IA1_TQ3,0.07142857142857142,0.9714285714285714,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+883,AF3,1Q1G_MTI,1.1764705882352942,0.5294117647058824,{},"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+884,AF3,1R1H_BIR,0.25,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+885,AF3,1YVF_PH7,0.15000000000000005,0.94,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+886,AF3,1YQY_915,0.10526315789473678,0.9578947368421052,"{'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+887,AF3,1HWW_SWA,0.2727272727272728,0.8909090909090909,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+888,AF3,1T40_ID5,0.33333333333333337,0.8666666666666667,"{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+889,AF3,1GKC_NFH,0.21052631578947367,0.9157894736842105,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+890,AF3,1N1M_A3M,1.2727272727272725,0.49090909090909096,"{'UNL:LIG:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2}"
+891,AF3,1Z95_198,0.1333333333333333,0.9466666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+892,AF3,1HP0_AD3,0.23076923076923073,0.9076923076923077,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+893,AF3,1OF1_SCT,0.05882352941176472,0.9764705882352941,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+894,AF3,1SJ0_E4D,0.217391304347826,0.9130434782608696,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+895,AF3,1U4D_DBQ,0.23076923076923084,0.9076923076923077,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+896,AF3,1Q41_IXM,0.17647058823529416,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+897,AF3,1OWE_675,0.18181818181818174,0.9272727272727272,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+898,AF3,1OQ5_CEL,0.14285714285714285,0.9428571428571428,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+899,AF3,1SG0_STL,0.3333333333333333,0.8666666666666667,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+900,AF3,2BR1_PFP,0.14285714285714285,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+901,AF3,1UOU_CMU,0.2222222222222222,0.9111111111111111,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+902,AF3,1TZ8_DES,0.09999999999999998,0.96,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}"
+903,AF3,1R9O_FLP,0.3529411764705883,0.8588235294117647,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+904,AF3,1P2Y_NCT,0.16666666666666657,0.9333333333333333,"{'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+905,AF3,1V0P_PVB,0.31578947368421056,0.8736842105263158,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+906,AF3,1XOZ_CIA,0.0625,0.975,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+907,AF3,1R55_097,0.125,0.95,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+908,AF3,1YWR_LI9,0.09090909090909087,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+909,AF3,1HQ2_PH2,0.0,1.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+910,AF3,1MZC_BNE,0.06666666666666668,0.9733333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+911,AF3,1V4S_MRK,0.05000000000000002,0.98,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+912,AF3,1NAV_IH5,0.2,0.92,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+913,AF3,1JJE_BYS,0.04545454545454544,0.9818181818181818,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+914,AF3,1GM8_SOX,0.25000000000000006,0.9,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2}"
+915,AF3,1J3J_CP6,0.1764705882352941,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+916,AF3,1T9B_1CS,0.1875,0.925,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+917,AF3,1PMN_984,0.4375,0.825,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+918,AF3,1N2V_BDI,0.07692307692307693,0.9692307692307692,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+919,AF3,1GPK_HUP,0.3333333333333332,0.8666666666666667,"{'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+920,AF3,1W1P_GIO,1.0833333333333333,0.5666666666666667,{'UNL:PHE:VdWContact': 1},"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+921,AF3,1OF6_DTY,,0.0,,
+922,AF3,1S3V_TQD,0.39999999999999997,0.8400000000000001,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+923,AF3,1Y6B_AAX,0.11764705882352942,0.9529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+924,AF3,1L2S_STC,0.06666666666666667,0.9733333333333334,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+925,AF3,1W2G_THM,0.21428571428571425,0.9142857142857143,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+926,AF3,1TOW_CRZ,0.2,0.92,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+927,AF3,1XM6_5RM,0.13333333333333341,0.9466666666666667,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+928,AF3,1YGC_905,0.1666666666666667,0.9333333333333333,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+929,AF3,1R58_AO5,0.2777777777777778,0.8888888888888888,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+930,AF3,1HNN_SKF,0.1538461538461539,0.9384615384615385,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+931,AF3,1HVY_D16,0.3809523809523809,0.8476190476190477,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:UMP:Hydrophobic': 1, 'UNL:UMP:VdWContact': 1}"
+932,AF3,1OPK_P16,0.26315789473684215,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+933,AF3,1MMV_3AR,0.11764705882352942,0.9529411764705882,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+934,AF3,1SQN_NDR,0.1875,0.925,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
diff --git a/notebooks/astex_diverse_plif_wm_values.png b/notebooks/astex_diverse_plif_wm_values.png
new file mode 100644
index 00000000..824e6084
Binary files /dev/null and b/notebooks/astex_diverse_plif_wm_values.png differ
diff --git a/notebooks/astex_diverse_primary_ligand_relaxed_bar_chart.png b/notebooks/astex_diverse_primary_ligand_relaxed_bar_chart.png
new file mode 100644
index 00000000..fbc1ce98
Binary files /dev/null and b/notebooks/astex_diverse_primary_ligand_relaxed_bar_chart.png differ
diff --git a/notebooks/astex_diverse_primary_ligand_relaxed_rmsd_violin_plot.png b/notebooks/astex_diverse_primary_ligand_relaxed_rmsd_violin_plot.png
new file mode 100644
index 00000000..39d09633
Binary files /dev/null and b/notebooks/astex_diverse_primary_ligand_relaxed_rmsd_violin_plot.png differ
diff --git a/notebooks/astex_diverse_structured_plif_metrics.csv b/notebooks/astex_diverse_structured_plif_metrics.csv
new file mode 100644
index 00000000..48feba4d
--- /dev/null
+++ b/notebooks/astex_diverse_structured_plif_metrics.csv
@@ -0,0 +1,584 @@
+,Category,Target,Structured_EMD,Unstructured_EMD,Method_Histogram,Reference_Histogram
+0,P2Rank-Vina,2BM2_PM2,0.0,0.25,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1,P2Rank-Vina,1VCJ_IBA,1.0,0.8666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+2,P2Rank-Vina,1HWI_115,0.0,0.6190476190476192,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3,P2Rank-Vina,1UML_FR4,0.6666666666666667,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+4,P2Rank-Vina,1MEH_MOA,0.5,0.857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 7, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+5,P2Rank-Vina,2BSM_BSM,0.5,0.2777777777777777,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+6,P2Rank-Vina,1V48_HA1,0.7142857142857142,0.5,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+7,P2Rank-Vina,1JD0_AZM,0.16666666666666663,0.07692307692307687,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+8,P2Rank-Vina,1S19_MC9,0.5,0.3157894736842107,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+9,P2Rank-Vina,1LPZ_CMB,0.0,0.23529411764705885,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+10,P2Rank-Vina,1X8X_TYR,0.75,0.6000000000000001,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+11,P2Rank-Vina,1T46_STI,0.19999999999999996,0.6521739130434784,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+12,P2Rank-Vina,1IG3_VIB,0.0,0.5,"{'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+13,P2Rank-Vina,1SQ5_PAU,0.25,0.14285714285714296,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+14,P2Rank-Vina,1U1C_BAU,0.75,0.3571428571428572,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+15,P2Rank-Vina,1YQY_915,0.125,0.27777777777777773,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+16,P2Rank-Vina,1HWW_SWA,0.0,0.33333333333333326,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+17,P2Rank-Vina,1Z95_198,0.3333333333333333,0.25,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 5, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+18,P2Rank-Vina,1HP0_AD3,0.5,0.5454545454545454,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+19,P2Rank-Vina,1OF1_SCT,0.6000000000000001,0.3125,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+20,P2Rank-Vina,1SJ0_E4D,0.0,0.36363636363636365,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 5, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+21,P2Rank-Vina,1Q41_IXM,0.5,0.06666666666666665,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+22,P2Rank-Vina,1OQ5_CEL,0.0,0.375,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+23,P2Rank-Vina,1UOU_CMU,0.19999999999999996,0.5384615384615384,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+24,P2Rank-Vina,1XOZ_CIA,0.0,0.4444444444444444,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+25,P2Rank-Vina,1YWR_LI9,0.5,0.42105263157894746,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+26,P2Rank-Vina,1NAV_IH5,0.5,0.14285714285714282,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+27,P2Rank-Vina,1S3V_TQD,0.0,0.4285714285714286,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+28,P2Rank-Vina,1L2S_STC,0.5,0.33333333333333326,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+29,P2Rank-Vina,1W2G_THM,0.0,0.6666666666666667,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+30,P2Rank-Vina,1XM6_5RM,0.0,0.23529411764705885,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+31,P2Rank-Vina,1YGC_905,0.5,0.3999999999999999,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+32,P2Rank-Vina,1R58_AO5,0.25,0.16666666666666657,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+33,DiffDock-L,2BM2_PM2,0.0,0.3333333333333333,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+34,DiffDock-L,1XOQ_ROF,0.0,0.375,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+35,DiffDock-L,1M2Z_DEX,0.39999999999999997,0.22222222222222215,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+36,DiffDock-L,1P62_GEO,0.2,0.41666666666666674,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+37,DiffDock-L,1KE5_LS1,0.25,0.1875,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+38,DiffDock-L,1TT1_KAI,0.6,0.7,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+39,DiffDock-L,1VCJ_IBA,0.0,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+40,DiffDock-L,1HWI_115,0.3333333333333333,0.14285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+41,DiffDock-L,1UML_FR4,0.0,0.6666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 4, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+42,DiffDock-L,1JLA_TNK,0.0,0.3888888888888889,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+43,DiffDock-L,1N46_PFA,0.39999999999999997,0.0,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+44,DiffDock-L,1KZK_JE2,1.0,0.7692307692307692,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+45,DiffDock-L,1N2J_PAF,0.0,0.25,"{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+46,DiffDock-L,1MEH_MOA,0.19999999999999996,0.6428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+47,DiffDock-L,2BSM_BSM,0.3333333333333333,0.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+48,DiffDock-L,1V48_HA1,0.0,0.21428571428571422,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+49,DiffDock-L,1L7F_BCZ,1.0,0.41666666666666663,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 6, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+50,DiffDock-L,1JD0_AZM,0.33333333333333337,0.28571428571428564,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+51,DiffDock-L,1S19_MC9,0.25,0.15789473684210537,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+52,DiffDock-L,1LPZ_CMB,0.5,0.11764705882352944,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+53,DiffDock-L,1X8X_TYR,1.0,0.2000000000000001,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+54,DiffDock-L,1T46_STI,0.6666666666666666,0.21739130434782616,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+55,DiffDock-L,1IG3_VIB,0.19999999999999996,0.3571428571428571,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+56,DiffDock-L,1SQ5_PAU,0.5,0.18181818181818174,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+57,DiffDock-L,1OYT_FSN,0.3333333333333333,0.14285714285714282,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+58,DiffDock-L,1UNL_RRC,0.6666666666666666,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+59,DiffDock-L,1U1C_BAU,0.25,0.23076923076923078,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+60,DiffDock-L,1K3U_IAD,0.75,0.6428571428571428,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+61,DiffDock-L,1Q1G_MTI,0.0,0.11111111111111102,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+62,DiffDock-L,1R1H_BIR,0.5,0.39999999999999997,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+63,DiffDock-L,1YVF_PH7,0.0,0.04347826086956519,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+64,DiffDock-L,1YQY_915,0.33333333333333337,0.33333333333333337,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+65,DiffDock-L,1HWW_SWA,0.3333333333333333,0.19999999999999998,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+66,DiffDock-L,1N1M_A3M,0.0,0.25,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2}"
+67,DiffDock-L,1Z95_198,0.5,0.28571428571428586,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+68,DiffDock-L,1HP0_AD3,0.0,0.19999999999999998,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+69,DiffDock-L,1OF1_SCT,0.2,0.14285714285714282,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+70,DiffDock-L,1SJ0_E4D,0.6666666666666666,0.3636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+71,DiffDock-L,1U4D_DBQ,0.0,0.19999999999999998,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+72,DiffDock-L,1Q41_IXM,0.0,0.13333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+73,DiffDock-L,1OWE_675,0.3333333333333333,0.22222222222222215,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+74,DiffDock-L,1OQ5_CEL,0.0,0.2666666666666666,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+75,DiffDock-L,2BR1_PFP,0.0,0.49999999999999994,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+76,DiffDock-L,1UOU_CMU,0.3333333333333333,0.4166666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+77,DiffDock-L,1V0P_PVB,0.0,0.5,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+78,DiffDock-L,1XOZ_CIA,0.0,0.1333333333333333,"{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+79,DiffDock-L,1R55_097,0.2,0.19999999999999998,"{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+80,DiffDock-L,1YWR_LI9,0.5,0.2777777777777778,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+81,DiffDock-L,1HQ2_PH2,0.16666666666666666,0.09090909090909091,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+82,DiffDock-L,1V4S_MRK,0.6000000000000001,0.13636363636363635,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+83,DiffDock-L,1NAV_IH5,0.0,0.0714285714285714,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+84,DiffDock-L,1JJE_BYS,0.5,0.39999999999999997,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+85,DiffDock-L,1J3J_CP6,0.0,0.3333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+86,DiffDock-L,1N2V_BDI,0.3333333333333333,0.22222222222222215,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+87,DiffDock-L,1W1P_GIO,0.0,0.18181818181818174,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+88,DiffDock-L,1S3V_TQD,0.0,0.41666666666666663,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+89,DiffDock-L,1Y6B_AAX,0.6666666666666666,0.2857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+90,DiffDock-L,1L2S_STC,0.25,0.09090909090909091,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+91,DiffDock-L,1W2G_THM,0.5,0.4,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+92,DiffDock-L,1TOW_CRZ,0.3333333333333333,0.21428571428571422,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+93,DiffDock-L,1XM6_5RM,0.0,0.2857142857142857,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+94,DiffDock-L,1YGC_905,0.3333333333333333,0.1428571428571428,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+95,DiffDock-L,1R58_AO5,0.0,0.07692307692307693,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+96,DiffDock-L,1HNN_SKF,0.0,0.23076923076923078,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+97,DiffDock-L,1OPK_P16,0.0,0.21052631578947367,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+98,DiffDock-L,1SQN_NDR,0.5,0.21428571428571422,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+99,DynamicBind,1M2Z_DEX,0.16666666666666663,0.2222222222222223,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+100,DynamicBind,1P62_GEO,0.75,0.1818181818181818,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+101,DynamicBind,1KE5_LS1,0.5,0.20000000000000007,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+102,DynamicBind,1UML_FR4,0.0,0.3529411764705882,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+103,DynamicBind,1JLA_TNK,0.0,0.05882352941176472,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+104,DynamicBind,1N46_PFA,0.7999999999999999,0.11111111111111116,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+105,DynamicBind,1MEH_MOA,0.25,0.30000000000000004,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+106,DynamicBind,1V48_HA1,0.6666666666666666,0.2,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+107,DynamicBind,1L7F_BCZ,1.0,0.5714285714285714,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 6, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+108,DynamicBind,1JD0_AZM,0.33333333333333337,0.28571428571428575,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+109,DynamicBind,1LPZ_CMB,0.5,0.17647058823529416,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+110,DynamicBind,1OYT_FSN,0.0,0.14285714285714282,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+111,DynamicBind,1K3U_IAD,0.875,0.3333333333333332,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+112,DynamicBind,1IA1_TQ3,0.5,0.4166666666666667,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+113,DynamicBind,1Q1G_MTI,0.3333333333333333,0.21052631578947367,"{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+114,DynamicBind,1R1H_BIR,0.2,0.4,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+115,DynamicBind,1HWW_SWA,0.0,0.19999999999999998,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+116,DynamicBind,1GKC_NFH,0.33333333333333337,0.5,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+117,DynamicBind,1HP0_AD3,0.6666666666666667,0.09090909090909083,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+118,DynamicBind,1OF1_SCT,0.5,0.14285714285714282,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+119,DynamicBind,1U4D_DBQ,0.0,0.5,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+120,DynamicBind,1Q41_IXM,0.3333333333333333,0.19999999999999998,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+121,DynamicBind,1OWE_675,0.0,0.0,"{'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+122,DynamicBind,1OQ5_CEL,0.25,0.2941176470588236,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+123,DynamicBind,1UOU_CMU,0.3333333333333333,0.6363636363636364,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+124,DynamicBind,1R55_097,0.5,0.39999999999999997,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 4, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+125,DynamicBind,1HQ2_PH2,0.6666666666666666,0.0,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+126,DynamicBind,1MZC_BNE,0.3333333333333333,0.8181818181818181,"{'UNL:ALA:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 5, 'UNL:TYR:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+127,DynamicBind,1NAV_IH5,0.0,0.07142857142857142,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+128,DynamicBind,1JJE_BYS,0.25,0.22222222222222218,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+129,DynamicBind,1PMN_984,0.0,0.4666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+130,DynamicBind,1N2V_BDI,0.6666666666666667,0.09999999999999998,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+131,DynamicBind,1Y6B_AAX,0.3333333333333333,0.3529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+132,DynamicBind,1L2S_STC,0.5,0.08333333333333337,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+133,DynamicBind,1TOW_CRZ,0.3333333333333333,0.0714285714285714,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+134,DynamicBind,1YGC_905,0.0,0.1875,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+135,DynamicBind,1MMV_3AR,0.6666666666666667,0.52,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+136,NeuralPLexer,1KE5_LS1,0.5,0.33333333333333337,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+137,NeuralPLexer,1VCJ_IBA,1.5,0.125,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+138,NeuralPLexer,1HWI_115,0.3333333333333333,0.41666666666666663,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+139,NeuralPLexer,1UML_FR4,1.0,0.35714285714285704,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+140,NeuralPLexer,1JLA_TNK,0.0,0.26923076923076916,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+141,NeuralPLexer,1N46_PFA,1.0,0.33333333333333337,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+142,NeuralPLexer,1N2J_PAF,0.5,0.5,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+143,NeuralPLexer,1MEH_MOA,0.16666666666666669,0.5384615384615383,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+144,NeuralPLexer,1V48_HA1,0.6666666666666666,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+145,NeuralPLexer,1L7F_BCZ,0.9999999999999998,0.23076923076923073,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+146,NeuralPLexer,1JD0_AZM,0.75,0.2857142857142857,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+147,NeuralPLexer,1S19_MC9,0.5,0.21052631578947378,"{'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+148,NeuralPLexer,1X8X_TYR,0.3333333333333333,0.5555555555555556,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+149,NeuralPLexer,1T46_STI,0.5,0.2608695652173913,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+150,NeuralPLexer,1IG3_VIB,0.5,0.24999999999999994,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+151,NeuralPLexer,1SQ5_PAU,0.0,0.14285714285714285,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+152,NeuralPLexer,1OYT_FSN,0.25,0.23076923076923067,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+153,NeuralPLexer,1UNL_RRC,0.5,0.611111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+154,NeuralPLexer,1U1C_BAU,0.6000000000000001,0.23076923076923078,"{'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+155,NeuralPLexer,1K3U_IAD,0.875,0.5217391304347825,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+156,NeuralPLexer,1IA1_TQ3,0.5,0.36363636363636354,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+157,NeuralPLexer,1R1H_BIR,0.6000000000000001,0.4000000000000001,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+158,NeuralPLexer,1YQY_915,0.4,0.23529411764705882,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+159,NeuralPLexer,1HWW_SWA,0.25,0.3333333333333334,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 4, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+160,NeuralPLexer,1T40_ID5,0.6000000000000001,0.3333333333333333,"{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+161,NeuralPLexer,1GKC_NFH,0.8,0.4117647058823529,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+162,NeuralPLexer,1N1M_A3M,0.6666666666666667,0.38461538461538475,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2}"
+163,NeuralPLexer,1HP0_AD3,1.0,0.18181818181818182,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+164,NeuralPLexer,1U4D_DBQ,0.3999999999999999,0.7000000000000001,"{'UNL:ALA:Hydrophobic': 3, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBDonor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+165,NeuralPLexer,1OWE_675,0.0,0.33333333333333326,"{'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+166,NeuralPLexer,2BR1_PFP,0.0,0.46666666666666673,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+167,NeuralPLexer,1UOU_CMU,0.6666666666666666,0.5384615384615385,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+168,NeuralPLexer,1TZ8_DES,1.0,1.4285714285714284,"{'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 5}","{'UNL:ALA:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}"
+169,NeuralPLexer,1R55_097,0.6,0.36363636363636376,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+170,NeuralPLexer,1YWR_LI9,0.5,0.5555555555555556,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+171,NeuralPLexer,1HQ2_PH2,0.6666666666666666,0.0,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+172,NeuralPLexer,1MZC_BNE,0.0,0.3529411764705882,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+173,NeuralPLexer,1V4S_MRK,0.6000000000000001,0.11111111111111116,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+174,NeuralPLexer,1N2V_BDI,0.6666666666666666,0.3,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+175,NeuralPLexer,1S3V_TQD,0.0,0.16666666666666657,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+176,NeuralPLexer,1Y6B_AAX,0.25,0.16666666666666669,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+177,NeuralPLexer,1L2S_STC,0.6000000000000001,0.23076923076923073,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+178,NeuralPLexer,1W2G_THM,0.3333333333333333,0.25,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+179,NeuralPLexer,1TOW_CRZ,0.3333333333333333,0.33333333333333337,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+180,NeuralPLexer,1YGC_905,0.0,0.2222222222222223,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 4, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+181,NeuralPLexer,1R58_AO5,0.3333333333333333,0.27272727272727276,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+182,NeuralPLexer,1OPK_P16,0.5,0.1578947368421052,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+183,RFAA,1P62_GEO,0.75,0.3076923076923077,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+184,RFAA,1KE5_LS1,0.5,0.7692307692307693,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+185,RFAA,1TT1_KAI,0.8333333333333334,0.19999999999999996,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+186,RFAA,1VCJ_IBA,1.0,0.8666666666666666,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+187,RFAA,1KZK_JE2,0.3333333333333333,0.7692307692307692,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 5, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PRO:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+188,RFAA,1V48_HA1,0.8333333333333334,0.28571428571428575,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+189,RFAA,1L7F_BCZ,0.5999999999999999,0.28571428571428575,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+190,RFAA,1S19_MC9,0.3999999999999999,0.6666666666666667,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+191,RFAA,1LPZ_CMB,0.5,0.27777777777777785,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+192,RFAA,1X8X_TYR,0.5,0.5000000000000001,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+193,RFAA,1T46_STI,0.25,0.6521739130434784,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+194,RFAA,1IG3_VIB,0.0,0.33333333333333326,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+195,RFAA,1K3U_IAD,0.8571428571428572,0.6,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+196,RFAA,1R1H_BIR,0.75,0.20000000000000007,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+197,RFAA,1YVF_PH7,0.0,0.21739130434782605,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+198,RFAA,1T40_ID5,0.6000000000000001,0.25,"{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+199,RFAA,1GKC_NFH,0.4,0.3333333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+200,RFAA,1OF1_SCT,0.6000000000000001,0.4000000000000001,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+201,RFAA,1OWE_675,0.0,0.29999999999999993,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+202,RFAA,1SG0_STL,0.3333333333333333,0.5833333333333334,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+203,RFAA,2BR1_PFP,0.0,0.06666666666666665,"{'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+204,RFAA,1UOU_CMU,0.5,0.8181818181818182,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+205,RFAA,1R55_097,0.16666666666666663,0.7272727272727273,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 4, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+206,RFAA,1YWR_LI9,0.5,0.7368421052631581,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+207,RFAA,1HQ2_PH2,0.3333333333333333,0.08333333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+208,RFAA,1V4S_MRK,0.3333333333333333,0.3157894736842105,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+209,RFAA,1PMN_984,0.5,0.5,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 3, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+210,RFAA,1N2V_BDI,0.0,0.33333333333333337,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+211,RFAA,1S3V_TQD,0.0,0.16666666666666657,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+212,RFAA,1Y6B_AAX,0.3333333333333333,0.3571428571428571,"{'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+213,RFAA,1W2G_THM,0.39999999999999997,0.1875,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+214,RFAA,1YGC_905,0.6666666666666667,0.17647058823529416,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+215,RFAA,1R58_AO5,0.39999999999999997,0.6666666666666667,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+216,RFAA,1HNN_SKF,0.0,0.5714285714285714,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 5, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+217,RFAA,1OPK_P16,0.0,0.24999999999999994,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+218,Chai-1-Single-Seq,2BM2_PM2,0.0,0.21428571428571436,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+219,Chai-1-Single-Seq,1XOQ_ROF,0.0,0.23076923076923084,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+220,Chai-1-Single-Seq,1M2Z_DEX,0.39999999999999997,0.052631578947368474,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+221,Chai-1-Single-Seq,1P62_GEO,0.2,0.36363636363636365,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+222,Chai-1-Single-Seq,1KE5_LS1,0.0,0.25,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+223,Chai-1-Single-Seq,1TT1_KAI,0.16666666666666666,0.09999999999999998,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+224,Chai-1-Single-Seq,1UML_FR4,1.0,0.3333333333333333,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+225,Chai-1-Single-Seq,1JLA_TNK,0.0,0.33333333333333337,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+226,Chai-1-Single-Seq,1N46_PFA,0.7999999999999999,0.25,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+227,Chai-1-Single-Seq,1LRH_NLA,0.0,0.2941176470588236,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+228,Chai-1-Single-Seq,1KZK_JE2,0.5,0.6666666666666665,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 5, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 6, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+229,Chai-1-Single-Seq,1N2J_PAF,0.0,0.0,"{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+230,Chai-1-Single-Seq,2BSM_BSM,0.0,0.11111111111111102,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+231,Chai-1-Single-Seq,1V48_HA1,0.3333333333333333,0.0,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+232,Chai-1-Single-Seq,1L7F_BCZ,1.25,0.23076923076923084,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+233,Chai-1-Single-Seq,1JD0_AZM,0.6666666666666667,0.14285714285714285,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+234,Chai-1-Single-Seq,1S19_MC9,0.3333333333333333,0.2941176470588236,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+235,Chai-1-Single-Seq,1LPZ_CMB,0.0,0.26315789473684215,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+236,Chai-1-Single-Seq,1X8X_TYR,0.6666666666666667,0.22222222222222215,"{'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+237,Chai-1-Single-Seq,1T46_STI,0.25,0.45833333333333337,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+238,Chai-1-Single-Seq,1IG3_VIB,0.0,0.33333333333333337,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+239,Chai-1-Single-Seq,1SQ5_PAU,0.25,0.41666666666666663,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+240,Chai-1-Single-Seq,1Q4G_BFL,0.3333333333333333,0.6000000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+241,Chai-1-Single-Seq,1OYT_FSN,0.0,0.3125,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+242,Chai-1-Single-Seq,1UNL_RRC,0.3333333333333333,0.375,"{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+243,Chai-1-Single-Seq,1U1C_BAU,0.25,0.42857142857142855,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+244,Chai-1-Single-Seq,1K3U_IAD,0.2857142857142857,0.14285714285714282,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+245,Chai-1-Single-Seq,1IA1_TQ3,0.0,0.23076923076923078,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+246,Chai-1-Single-Seq,1R1H_BIR,0.0,0.4375,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+247,Chai-1-Single-Seq,1YQY_915,0.0,0.1428571428571429,"{'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+248,Chai-1-Single-Seq,1T40_ID5,0.5,0.28571428571428575,"{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+249,Chai-1-Single-Seq,1GKC_NFH,0.2,0.21428571428571427,"{'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+250,Chai-1-Single-Seq,1Z95_198,0.0,0.14285714285714293,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+251,Chai-1-Single-Seq,1HP0_AD3,0.5,0.09090909090909088,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+252,Chai-1-Single-Seq,1OF1_SCT,0.2,0.13333333333333333,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+253,Chai-1-Single-Seq,1SJ0_E4D,0.25,0.10526315789473689,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+254,Chai-1-Single-Seq,1U4D_DBQ,0.0,0.36363636363636354,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+255,Chai-1-Single-Seq,1Q41_IXM,0.0,0.14285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+256,Chai-1-Single-Seq,1OWE_675,0.0,0.25,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+257,Chai-1-Single-Seq,1OQ5_CEL,0.0,0.16666666666666674,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+258,Chai-1-Single-Seq,2BR1_PFP,0.0,0.0714285714285714,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+259,Chai-1-Single-Seq,1UOU_CMU,0.0,0.2,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+260,Chai-1-Single-Seq,1R9O_FLP,0.5,0.3125,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+261,Chai-1-Single-Seq,1V0P_PVB,0.0,0.3125,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+262,Chai-1-Single-Seq,1XOZ_CIA,0.0,0.06666666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+263,Chai-1-Single-Seq,1R55_097,0.0,0.09999999999999998,"{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+264,Chai-1-Single-Seq,1YWR_LI9,0.3333333333333333,0.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+265,Chai-1-Single-Seq,1HQ2_PH2,0.0,0.0,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+266,Chai-1-Single-Seq,1V4S_MRK,0.3333333333333333,0.2777777777777778,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+267,Chai-1-Single-Seq,1NAV_IH5,0.5,0.1875,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+268,Chai-1-Single-Seq,1JJE_BYS,0.6666666666666666,0.0625,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+269,Chai-1-Single-Seq,1J3J_CP6,0.0,0.26666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+270,Chai-1-Single-Seq,1T9B_1CS,0.0,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+271,Chai-1-Single-Seq,1PMN_984,0.5,0.4666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+272,Chai-1-Single-Seq,1N2V_BDI,0.0,0.3333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+273,Chai-1-Single-Seq,1S3V_TQD,0.3333333333333333,0.4615384615384616,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+274,Chai-1-Single-Seq,1Y6B_AAX,0.0,0.17647058823529416,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+275,Chai-1-Single-Seq,1L2S_STC,0.0,0.36363636363636354,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+276,Chai-1-Single-Seq,1W2G_THM,0.0,0.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+277,Chai-1-Single-Seq,1TOW_CRZ,0.5,0.07692307692307687,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+278,Chai-1-Single-Seq,1XM6_5RM,0.5,0.21428571428571422,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+279,Chai-1-Single-Seq,1YGC_905,0.3333333333333333,0.1538461538461538,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+280,Chai-1-Single-Seq,1R58_AO5,0.0,0.21428571428571422,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+281,Chai-1-Single-Seq,1HNN_SKF,0.0,0.4545454545454546,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+282,Chai-1-Single-Seq,1SQN_NDR,0.5,0.2857142857142857,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+283,Chai-1,2BM2_PM2,0.5,0.26666666666666666,"{'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+284,Chai-1,1XOQ_ROF,0.0,0.21428571428571433,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+285,Chai-1,1M2Z_DEX,0.75,0.17647058823529413,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+286,Chai-1,1P62_GEO,0.2,0.25,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+287,Chai-1,1KE5_LS1,0.0,0.14285714285714293,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+288,Chai-1,1TT1_KAI,0.16666666666666666,0.18181818181818174,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+289,Chai-1,1VCJ_IBA,0.5,0.19999999999999996,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+290,Chai-1,1HWI_115,0.5,0.31578947368421056,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+291,Chai-1,1UML_FR4,0.0,0.3076923076923078,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+292,Chai-1,1JLA_TNK,0.3333333333333333,0.040000000000000036,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+293,Chai-1,1N46_PFA,0.4,0.3125,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+294,Chai-1,1KZK_JE2,0.5,0.36363636363636365,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+295,Chai-1,1N2J_PAF,0.6666666666666667,0.49999999999999994,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+296,Chai-1,1MEH_MOA,0.3333333333333333,0.375,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+297,Chai-1,2BSM_BSM,0.0,0.1111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+298,Chai-1,1V48_HA1,0.16666666666666666,0.07692307692307693,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+299,Chai-1,1L7F_BCZ,0.25,0.4,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+300,Chai-1,1JD0_AZM,0.33333333333333337,0.25,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+301,Chai-1,1S19_MC9,0.25,0.3529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+302,Chai-1,1LPZ_CMB,0.5,0.17647058823529416,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+303,Chai-1,1X8X_TYR,0.5,0.2222222222222221,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+304,Chai-1,1T46_STI,0.25,0.45833333333333337,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+305,Chai-1,1IG3_VIB,0.0,0.27272727272727276,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+306,Chai-1,1Q4G_BFL,0.3333333333333333,0.41666666666666674,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+307,Chai-1,1OYT_FSN,0.3333333333333333,0.1875,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+308,Chai-1,1UNL_RRC,0.3333333333333333,0.17647058823529416,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+309,Chai-1,1U1C_BAU,0.25,0.33333333333333326,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+310,Chai-1,1K3U_IAD,0.08333333333333337,0.19047619047619058,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+311,Chai-1,1IA1_TQ3,0.0,0.09090909090909091,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+312,Chai-1,1Q1G_MTI,0.0,0.06666666666666667,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+313,Chai-1,1R1H_BIR,0.25,0.13333333333333341,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+314,Chai-1,1YVF_PH7,0.3333333333333333,0.08333333333333331,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+315,Chai-1,1YQY_915,0.4,0.0714285714285714,"{'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+316,Chai-1,1HWW_SWA,1.0,0.11111111111111116,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+317,Chai-1,1T40_ID5,0.5,0.28571428571428575,"{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+318,Chai-1,1GKC_NFH,0.39999999999999997,0.14285714285714285,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+319,Chai-1,1Z95_198,0.0,0.07142857142857142,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+320,Chai-1,1HP0_AD3,0.6666666666666666,0.29999999999999993,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+321,Chai-1,1OF1_SCT,0.5,0.15384615384615374,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+322,Chai-1,1SJ0_E4D,0.25,0.19047619047619052,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+323,Chai-1,1U4D_DBQ,0.3333333333333333,0.19999999999999998,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+324,Chai-1,1Q41_IXM,0.0,0.08333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+325,Chai-1,1OWE_675,0.0,0.375,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+326,Chai-1,1OQ5_CEL,0.0,0.11764705882352944,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+327,Chai-1,1SG0_STL,0.5,0.33333333333333337,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+328,Chai-1,2BR1_PFP,0.0,0.14285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+329,Chai-1,1UOU_CMU,0.3333333333333333,0.08333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+330,Chai-1,1TZ8_DES,0.5,0.5,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}"
+331,Chai-1,1R9O_FLP,0.5,0.33333333333333337,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+332,Chai-1,1V0P_PVB,0.5,0.6666666666666666,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+333,Chai-1,1XOZ_CIA,0.0,0.13333333333333336,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+334,Chai-1,1R55_097,0.0,0.20000000000000007,"{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+335,Chai-1,1YWR_LI9,0.0,0.05263157894736836,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+336,Chai-1,1HQ2_PH2,0.16666666666666666,0.09090909090909091,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+337,Chai-1,1MZC_BNE,0.5,0.09090909090909083,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+338,Chai-1,1V4S_MRK,0.25,0.1176470588235293,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+339,Chai-1,1NAV_IH5,0.3333333333333333,0.28571428571428575,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+340,Chai-1,1JJE_BYS,0.25,0.26666666666666666,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+341,Chai-1,1J3J_CP6,0.5,0.24999999999999994,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+342,Chai-1,1T9B_1CS,0.0,0.14285714285714293,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+343,Chai-1,1PMN_984,0.5,0.2857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+344,Chai-1,1N2V_BDI,0.0,0.2,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+345,Chai-1,1S3V_TQD,0.0,0.3636363636363636,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+346,Chai-1,1Y6B_AAX,0.0,0.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+347,Chai-1,1L2S_STC,0.0,0.2727272727272727,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+348,Chai-1,1W2G_THM,0.3333333333333333,0.09999999999999998,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+349,Chai-1,1TOW_CRZ,0.0,0.23076923076923067,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+350,Chai-1,1XM6_5RM,0.0,0.23076923076923084,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+351,Chai-1,1YGC_905,0.3333333333333333,0.2857142857142857,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+352,Chai-1,1R58_AO5,0.0,0.28571428571428564,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+353,Chai-1,1OPK_P16,0.0,0.1875,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+354,Chai-1,1MMV_3AR,0.3333333333333333,0.07692307692307693,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+355,Chai-1,1SQN_NDR,0.0,0.1428571428571429,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+356,Boltz-1-Single-Seq,1M2Z_DEX,0.0,0.2222222222222222,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+357,Boltz-1-Single-Seq,1P62_GEO,0.0,0.3846153846153846,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+358,Boltz-1-Single-Seq,1KE5_LS1,0.25,0.07142857142857142,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+359,Boltz-1-Single-Seq,1TT1_KAI,0.0,0.16666666666666657,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+360,Boltz-1-Single-Seq,1VCJ_IBA,1.0,0.3571428571428571,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+361,Boltz-1-Single-Seq,1UML_FR4,0.0,0.23076923076923078,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+362,Boltz-1-Single-Seq,1JLA_TNK,0.0,0.27777777777777785,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+363,Boltz-1-Single-Seq,1N46_PFA,0.39999999999999997,0.11764705882352942,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+364,Boltz-1-Single-Seq,1KZK_JE2,0.5,0.6363636363636364,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+365,Boltz-1-Single-Seq,1N2J_PAF,1.0,0.0,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+366,Boltz-1-Single-Seq,1MEH_MOA,0.6666666666666666,0.11111111111111105,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+367,Boltz-1-Single-Seq,2BSM_BSM,0.0,0.05555555555555555,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+368,Boltz-1-Single-Seq,1V48_HA1,0.0,0.06666666666666668,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+369,Boltz-1-Single-Seq,1L7F_BCZ,0.19999999999999996,0.16666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+370,Boltz-1-Single-Seq,1JD0_AZM,0.0,0.28571428571428564,"{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+371,Boltz-1-Single-Seq,1S19_MC9,0.25,0.2941176470588236,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+372,Boltz-1-Single-Seq,1X8X_TYR,1.0,0.11111111111111105,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+373,Boltz-1-Single-Seq,1T46_STI,0.0,0.09999999999999998,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+374,Boltz-1-Single-Seq,1IG3_VIB,0.0,0.18181818181818185,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+375,Boltz-1-Single-Seq,1OYT_FSN,0.0,0.2000000000000001,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+376,Boltz-1-Single-Seq,1K3U_IAD,0.7142857142857144,0.23076923076923073,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+377,Boltz-1-Single-Seq,1YV3_BIT,0.6666666666666666,0.23529411764705876,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+378,Boltz-1-Single-Seq,1IA1_TQ3,0.0,0.08333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+379,Boltz-1-Single-Seq,1R1H_BIR,0.2,0.2857142857142856,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+380,Boltz-1-Single-Seq,1YVF_PH7,0.0,0.19047619047619052,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+381,Boltz-1-Single-Seq,1YQY_915,0.0,0.125,"{'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+382,Boltz-1-Single-Seq,1HWW_SWA,0.3333333333333333,0.11111111111111116,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+383,Boltz-1-Single-Seq,1T40_ID5,0.25,0.4285714285714286,"{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+384,Boltz-1-Single-Seq,1Z95_198,0.6666666666666666,0.06666666666666665,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+385,Boltz-1-Single-Seq,1HP0_AD3,0.0,0.0,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+386,Boltz-1-Single-Seq,1OF1_SCT,0.0,0.14285714285714282,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+387,Boltz-1-Single-Seq,1SJ0_E4D,0.25,0.10000000000000009,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+388,Boltz-1-Single-Seq,1U4D_DBQ,0.3333333333333333,0.22222222222222215,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+389,Boltz-1-Single-Seq,1Q41_IXM,0.0,0.14285714285714282,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+390,Boltz-1-Single-Seq,1OWE_675,0.0,0.5,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+391,Boltz-1-Single-Seq,1OQ5_CEL,0.25,0.17647058823529416,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+392,Boltz-1-Single-Seq,1SG0_STL,0.5,0.14285714285714285,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+393,Boltz-1-Single-Seq,2BR1_PFP,0.0,0.16666666666666669,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+394,Boltz-1-Single-Seq,1UOU_CMU,0.3333333333333333,0.3636363636363637,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+395,Boltz-1-Single-Seq,1V0P_PVB,0.0,0.49999999999999994,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+396,Boltz-1-Single-Seq,1XOZ_CIA,0.0,0.19999999999999996,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+397,Boltz-1-Single-Seq,1R55_097,0.0,0.30000000000000004,"{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+398,Boltz-1-Single-Seq,1YWR_LI9,0.0,0.21052631578947367,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+399,Boltz-1-Single-Seq,1HQ2_PH2,0.0,0.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+400,Boltz-1-Single-Seq,1V4S_MRK,0.25,0.13333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+401,Boltz-1-Single-Seq,1NAV_IH5,0.6,0.19999999999999996,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+402,Boltz-1-Single-Seq,1JJE_BYS,0.6666666666666666,0.49999999999999994,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+403,Boltz-1-Single-Seq,1PMN_984,0.5,0.4375,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+404,Boltz-1-Single-Seq,1N2V_BDI,0.0,0.36363636363636365,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+405,Boltz-1-Single-Seq,1S3V_TQD,0.3333333333333333,0.4545454545454545,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+406,Boltz-1-Single-Seq,1Y6B_AAX,0.0,0.2666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+407,Boltz-1-Single-Seq,1L2S_STC,0.5,0.07142857142857151,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+408,Boltz-1-Single-Seq,1W2G_THM,0.3333333333333333,0.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+409,Boltz-1-Single-Seq,1TOW_CRZ,0.5,0.1333333333333333,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+410,Boltz-1-Single-Seq,1XM6_5RM,0.5,0.3333333333333333,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+411,Boltz-1-Single-Seq,1R58_AO5,0.3333333333333333,0.4166666666666668,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+412,Boltz-1-Single-Seq,1HNN_SKF,0.5,0.08333333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+413,Boltz-1-Single-Seq,1OPK_P16,0.0,0.31578947368421056,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+414,Boltz-1-Single-Seq,1SQN_NDR,0.5,0.21428571428571422,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+415,Boltz-1,1M2Z_DEX,0.2,0.1666666666666666,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+416,Boltz-1,1P62_GEO,0.2,0.3846153846153846,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+417,Boltz-1,1KE5_LS1,0.25,0.14285714285714293,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+418,Boltz-1,1TT1_KAI,0.16666666666666666,0.15384615384615385,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+419,Boltz-1,1VCJ_IBA,1.0,0.05882352941176472,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+420,Boltz-1,1UML_FR4,0.0,0.28571428571428564,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+421,Boltz-1,1JLA_TNK,0.0,0.38888888888888884,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+422,Boltz-1,1N46_PFA,0.4,0.25,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+423,Boltz-1,1KZK_JE2,0.5,0.5,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+424,Boltz-1,1MEH_MOA,0.6666666666666666,0.3,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+425,Boltz-1,2BSM_BSM,0.0,0.11764705882352942,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+426,Boltz-1,1V48_HA1,0.33333333333333326,0.06666666666666668,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+427,Boltz-1,1L7F_BCZ,0.25,0.2727272727272728,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+428,Boltz-1,1JD0_AZM,0.0,0.28571428571428564,"{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+429,Boltz-1,1S19_MC9,0.25,0.23529411764705888,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+430,Boltz-1,1X8X_TYR,0.5,0.11111111111111105,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+431,Boltz-1,1T46_STI,0.0,0.14285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+432,Boltz-1,1IG3_VIB,0.0,0.18181818181818185,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+433,Boltz-1,1OYT_FSN,0.0,0.3125,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+434,Boltz-1,1K3U_IAD,0.42857142857142855,0.2857142857142857,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+435,Boltz-1,1YV3_BIT,0.3333333333333333,0.27777777777777785,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+436,Boltz-1,1IA1_TQ3,0.0,0.08333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+437,Boltz-1,1R1H_BIR,0.25,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+438,Boltz-1,1YVF_PH7,0.0,0.18181818181818177,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+439,Boltz-1,1YQY_915,0.16666666666666666,0.23529411764705882,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+440,Boltz-1,1HWW_SWA,0.25,0.11111111111111116,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+441,Boltz-1,1T40_ID5,0.0,0.3571428571428572,"{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+442,Boltz-1,1Z95_198,0.6666666666666666,0.14285714285714293,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+443,Boltz-1,1HP0_AD3,0.0,0.1,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+444,Boltz-1,1OF1_SCT,0.2,0.23076923076923073,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+445,Boltz-1,1SJ0_E4D,0.25,0.19047619047619058,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+446,Boltz-1,1U4D_DBQ,0.3333333333333333,0.22222222222222215,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+447,Boltz-1,1Q41_IXM,0.0,0.07692307692307687,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+448,Boltz-1,1OWE_675,0.0,0.375,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+449,Boltz-1,1OQ5_CEL,0.0,0.17647058823529416,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+450,Boltz-1,2BR1_PFP,0.0,0.08333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+451,Boltz-1,1UOU_CMU,0.3333333333333333,0.3636363636363637,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+452,Boltz-1,1V0P_PVB,0.0,0.35294117647058826,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+453,Boltz-1,1XOZ_CIA,0.0,0.06666666666666665,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+454,Boltz-1,1R55_097,0.0,0.19999999999999996,"{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+455,Boltz-1,1YWR_LI9,0.0,0.10526315789473684,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+456,Boltz-1,1HQ2_PH2,0.0,0.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+457,Boltz-1,1V4S_MRK,0.25,0.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+458,Boltz-1,1NAV_IH5,0.5,0.19999999999999998,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+459,Boltz-1,1JJE_BYS,0.6666666666666666,0.46666666666666673,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+460,Boltz-1,1PMN_984,0.5,0.3571428571428571,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+461,Boltz-1,1N2V_BDI,0.0,0.2727272727272727,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+462,Boltz-1,1S3V_TQD,0.3333333333333333,0.2727272727272726,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+463,Boltz-1,1Y6B_AAX,0.0,0.3571428571428573,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+464,Boltz-1,1L2S_STC,0.75,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+465,Boltz-1,1W2G_THM,0.5,0.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+466,Boltz-1,1TOW_CRZ,0.5,0.20000000000000007,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+467,Boltz-1,1XM6_5RM,0.0,0.23076923076923078,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+468,Boltz-1,1R58_AO5,0.5,0.23076923076923067,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+469,Boltz-1,1HNN_SKF,0.0,0.07692307692307693,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+470,Boltz-1,1OPK_P16,0.0,0.42105263157894735,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+471,Boltz-1,1SQN_NDR,0.5,0.0714285714285714,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+472,AF3-Single-Seq,2BM2_PM2,0.0,0.5000000000000001,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+473,AF3-Single-Seq,1P62_GEO,0.75,0.14285714285714285,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+474,AF3-Single-Seq,1TT1_KAI,0.8333333333333334,0.8181818181818181,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+475,AF3-Single-Seq,1VCJ_IBA,0.6666666666666666,0.5000000000000001,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+476,AF3-Single-Seq,1UML_FR4,0.3333333333333333,0.47619047619047605,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+477,AF3-Single-Seq,1KZK_JE2,0.0,0.5000000000000001,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:ILE:Hydrophobic': 6, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+478,AF3-Single-Seq,1MEH_MOA,0.19999999999999996,0.09090909090909088,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+479,AF3-Single-Seq,2BSM_BSM,0.5,0.4285714285714286,"{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+480,AF3-Single-Seq,1V48_HA1,0.375,0.2941176470588236,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+481,AF3-Single-Seq,1L7F_BCZ,1.25,0.41666666666666663,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+482,AF3-Single-Seq,1JD0_AZM,0.75,1.1428571428571428,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+483,AF3-Single-Seq,1X8X_TYR,1.0,0.46153846153846156,"{'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+484,AF3-Single-Seq,1UNL_RRC,0.0,0.5789473684210527,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+485,AF3-Single-Seq,1K3U_IAD,1.0,0.6666666666666665,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+486,AF3-Single-Seq,1Q1G_MTI,0.5,0.8125,"{'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LIG:HBDonor': 1, 'UNL:LIG:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+487,AF3-Single-Seq,1R1H_BIR,0.75,0.16666666666666669,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+488,AF3-Single-Seq,1YVF_PH7,0.3333333333333333,0.34615384615384615,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+489,AF3-Single-Seq,1YQY_915,0.6,0.35714285714285715,"{'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+490,AF3-Single-Seq,1HWW_SWA,0.3333333333333333,0.6153846153846153,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+491,AF3-Single-Seq,1T40_ID5,0.75,0.33333333333333337,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+492,AF3-Single-Seq,1HP0_AD3,0.5,0.5454545454545454,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+493,AF3-Single-Seq,1U4D_DBQ,0.5,0.1538461538461538,"{'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+494,AF3-Single-Seq,1OWE_675,0.0,0.5833333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+495,AF3-Single-Seq,1SG0_STL,0.3333333333333333,0.6000000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+496,AF3-Single-Seq,1UOU_CMU,0.5,0.3333333333333334,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+497,AF3-Single-Seq,1R9O_FLP,0.3333333333333333,0.09523809523809534,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+498,AF3-Single-Seq,1V0P_PVB,0.0,0.5652173913043479,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+499,AF3-Single-Seq,1XOZ_CIA,0.0,0.38888888888888884,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+500,AF3-Single-Seq,1R55_097,0.6666666666666666,0.23076923076923073,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+501,AF3-Single-Seq,1HQ2_PH2,0.8333333333333334,0.14285714285714285,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+502,AF3-Single-Seq,1V4S_MRK,0.14285714285714285,0.08695652173913038,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+503,AF3-Single-Seq,1NAV_IH5,0.0,0.3684210526315789,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+504,AF3-Single-Seq,1JJE_BYS,0.5,0.10000000000000003,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+505,AF3-Single-Seq,1J3J_CP6,0.6666666666666667,0.11764705882352944,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+506,AF3-Single-Seq,1N2V_BDI,0.19999999999999996,0.5499999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+507,AF3-Single-Seq,1L2S_STC,0.3333333333333333,0.33333333333333326,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+508,AF3-Single-Seq,1TOW_CRZ,0.0,0.21428571428571422,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+509,AF3-Single-Seq,1R58_AO5,0.19999999999999996,0.27777777777777785,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+510,AF3-Single-Seq,1MMV_3AR,0.3333333333333333,0.7692307692307692,"{'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+511,AF3-Single-Seq,1SQN_NDR,0.5,0.49999999999999994,"{'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+512,AF3,2BM2_PM2,0.0,0.16666666666666663,"{'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+513,AF3,1M2Z_DEX,0.25,0.2222222222222222,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+514,AF3,1P62_GEO,0.0,0.2727272727272727,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+515,AF3,1KE5_LS1,0.25,0.07142857142857142,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+516,AF3,1TT1_KAI,0.16666666666666666,0.16666666666666657,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+517,AF3,1VCJ_IBA,1.0,0.2,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+518,AF3,1HWI_115,0.5,0.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+519,AF3,1UML_FR4,0.0,0.16666666666666663,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+520,AF3,1JLA_TNK,0.0,0.17647058823529405,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+521,AF3,1N46_PFA,0.39999999999999997,0.1875,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+522,AF3,1KZK_JE2,0.5,0.5454545454545454,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 5, 'UNL:ILE:Hydrophobic': 6, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 3, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 6, 'UNL:LEU:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}"
+523,AF3,1N2J_PAF,0.0,0.22222222222222215,"{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+524,AF3,1MEH_MOA,0.0,0.25,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}"
+525,AF3,2BSM_BSM,0.0,0.1875,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+526,AF3,1V48_HA1,0.3333333333333333,0.1875,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+527,AF3,1L7F_BCZ,0.0,0.20000000000000007,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+528,AF3,1JD0_AZM,0.0,0.42857142857142855,"{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+529,AF3,1S19_MC9,0.0,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+530,AF3,1LPZ_CMB,0.3333333333333333,0.0625,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+531,AF3,1X8X_TYR,1.0,0.11111111111111105,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+532,AF3,1T46_STI,0.0,0.23809523809523808,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4}"
+533,AF3,1IG3_VIB,0.5,0.11111111111111116,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+534,AF3,1OYT_FSN,0.0,0.3125,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+535,AF3,1UNL_RRC,0.3333333333333333,0.47368421052631576,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+536,AF3,1U1C_BAU,0.25,0.16666666666666666,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+537,AF3,1K3U_IAD,0.5,0.3076923076923076,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+538,AF3,1IA1_TQ3,0.0,0.08333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+539,AF3,1R1H_BIR,0.25,0.375,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+540,AF3,1YVF_PH7,0.0,0.1578947368421053,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+541,AF3,1YQY_915,0.2,0.0714285714285714,"{'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+542,AF3,1HWW_SWA,1.0,0.11111111111111116,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+543,AF3,1T40_ID5,0.5,0.2857142857142858,"{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+544,AF3,1GKC_NFH,0.19999999999999996,0.21428571428571425,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+545,AF3,1Z95_198,0.0,0.1428571428571429,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+546,AF3,1HP0_AD3,0.6666666666666666,0.10000000000000009,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+547,AF3,1OF1_SCT,0.25,0.1538461538461538,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+548,AF3,1SJ0_E4D,0.0,0.26315789473684226,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+549,AF3,1U4D_DBQ,0.6666666666666666,0.09999999999999998,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+550,AF3,1Q41_IXM,0.0,0.21428571428571425,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+551,AF3,1OWE_675,0.3333333333333333,0.125,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+552,AF3,1OQ5_CEL,0.0,0.16666666666666674,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+553,AF3,1SG0_STL,0.3333333333333333,0.33333333333333337,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+554,AF3,2BR1_PFP,0.0,0.15384615384615385,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+555,AF3,1UOU_CMU,0.3333333333333333,0.20000000000000007,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+556,AF3,1TZ8_DES,0.0,0.125,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}"
+557,AF3,1R9O_FLP,0.5,0.33333333333333337,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+558,AF3,1V0P_PVB,0.0,0.35294117647058826,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+559,AF3,1XOZ_CIA,0.0,0.06666666666666665,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+560,AF3,1R55_097,0.16666666666666663,0.09999999999999998,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+561,AF3,1YWR_LI9,0.3333333333333333,0.05263157894736836,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+562,AF3,1HQ2_PH2,0.0,0.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+563,AF3,1MZC_BNE,0.0,0.08333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+564,AF3,1V4S_MRK,0.25,0.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+565,AF3,1NAV_IH5,0.6,0.06666666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+566,AF3,1JJE_BYS,0.33333333333333337,0.1875,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+567,AF3,1J3J_CP6,0.0,0.2,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+568,AF3,1T9B_1CS,0.0,0.2,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+569,AF3,1PMN_984,0.5,0.4285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+570,AF3,1N2V_BDI,0.0,0.1,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+571,AF3,1S3V_TQD,0.3333333333333333,0.41666666666666663,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+572,AF3,1Y6B_AAX,0.0,0.14285714285714293,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+573,AF3,1L2S_STC,0.0,0.1,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+574,AF3,1W2G_THM,0.5,0.09999999999999998,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+575,AF3,1TOW_CRZ,0.5,0.1538461538461538,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+576,AF3,1XM6_5RM,0.0,0.1428571428571429,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+577,AF3,1YGC_905,0.25,0.1428571428571429,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+578,AF3,1R58_AO5,0.25,0.28571428571428564,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+579,AF3,1HNN_SKF,0.0,0.16666666666666657,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+580,AF3,1OPK_P16,0.0,0.29411764705882343,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+581,AF3,1MMV_3AR,0.3333333333333333,0.07142857142857142,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+582,AF3,1SQN_NDR,0.5,0.14285714285714282,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
diff --git a/notebooks/astex_diverse_structured_vs_unstructured_emd_values.png b/notebooks/astex_diverse_structured_vs_unstructured_emd_values.png
new file mode 100644
index 00000000..54dcb747
Binary files /dev/null and b/notebooks/astex_diverse_structured_vs_unstructured_emd_values.png differ
diff --git a/notebooks/astex_method_interaction_analysis_plotting.ipynb b/notebooks/astex_method_interaction_analysis_plotting.ipynb
index 8fe5d64f..8b9c1fd5 100644
--- a/notebooks/astex_method_interaction_analysis_plotting.ipynb
+++ b/notebooks/astex_method_interaction_analysis_plotting.ipynb
@@ -88,6 +88,8 @@
" \"rfaa\",\n",
" \"chai-lab_ss\",\n",
" \"chai-lab\",\n",
+ " \"boltz_ss\",\n",
+ " \"boltz\",\n",
" \"alphafold3_ss\",\n",
" \"alphafold3\",\n",
"]\n",
@@ -102,7 +104,7 @@
")\n",
"assert os.path.exists(\n",
" ad_set_dir\n",
- "), \"Please download the Astex Diverse set from `https://zenodo.org/records/14629652` before proceeding.\"\n",
+ "), \"Please download the Astex Diverse set from `https://zenodo.org/records/16791095` before proceeding.\"\n",
"\n",
"# Mappings\n",
"method_mapping = {\n",
@@ -113,6 +115,8 @@
" \"rfaa\": \"RFAA\",\n",
" \"chai-lab_ss\": \"Chai-1-Single-Seq\",\n",
" \"chai-lab\": \"Chai-1\",\n",
+ " \"boltz_ss\": \"Boltz-1-Single-Seq\",\n",
+ " \"boltz\": \"Boltz-1\",\n",
" \"alphafold3_ss\": \"AF3-Single-Seq\",\n",
" \"alphafold3\": \"AF3\",\n",
"}\n",
diff --git a/notebooks/astex_method_interaction_analysis_plotting.py b/notebooks/astex_method_interaction_analysis_plotting.py
index 6e600ada..842b876d 100644
--- a/notebooks/astex_method_interaction_analysis_plotting.py
+++ b/notebooks/astex_method_interaction_analysis_plotting.py
@@ -53,6 +53,8 @@
"rfaa",
"chai-lab_ss",
"chai-lab",
+ "boltz_ss",
+ "boltz",
"alphafold3_ss",
"alphafold3",
]
@@ -67,7 +69,7 @@
)
assert os.path.exists(
ad_set_dir
-), "Please download the Astex Diverse set from `https://zenodo.org/records/14629652` before proceeding."
+), "Please download the Astex Diverse set from `https://zenodo.org/records/16791095` before proceeding."
# Mappings
method_mapping = {
@@ -78,6 +80,8 @@
"rfaa": "RFAA",
"chai-lab_ss": "Chai-1-Single-Seq",
"chai-lab": "Chai-1",
+ "boltz_ss": "Boltz-1-Single-Seq",
+ "boltz": "Boltz-1",
"alphafold3_ss": "AF3-Single-Seq",
"alphafold3": "AF3",
}
diff --git a/notebooks/biosynthetic_protein_pdb_report.csv b/notebooks/biosynthetic_protein_pdb_report.csv
new file mode 100644
index 00000000..28c8998e
--- /dev/null
+++ b/notebooks/biosynthetic_protein_pdb_report.csv
@@ -0,0 +1,1620 @@
+Entry ID,Deposition Date,Refinement Resolution (Å),Unnamed: 3
+1FC5,2000-07-17,2.2,
+1HO1,2000-12-08,2.0,
+1HO4,2000-12-08,2.3,
+1I24,2001-02-05,1.2,
+1I2B,2001-02-07,1.75,
+1I2C,2001-02-07,1.6,
+1IXN,2002-06-28,2.3,
+1IXO,2002-06-28,2.3,
+1IXP,2002-06-28,2.3,
+1IXQ,2002-06-28,2.3,
+1IZ6,2002-09-25,2.0,
+1JY8,2001-09-11,2.5,
+1L5A,2002-03-06,2.55,
+1M5W,2002-07-10,1.96,
+1MKZ,2002-08-29,1.6,
+1MWR,2002-10-01,2.45,
+1MWS,2002-10-01,2.0,
+1MWT,2002-10-01,2.45,
+1MWU,2002-10-01,2.6,
+1N0E,2002-10-13,2.7,
+1N0F,2002-10-13,2.8,
+1N0G,2002-10-13,2.8,
+1N9W,2002-11-26,2.3,
+1NCE,2002-12-05,2.4,
+1NP6,2003-01-17,1.9,
+1NQ4,2003-01-21,,
+1NWV,2003-02-07,,
+1O13,2002-10-15,1.83,
+1OR5,2003-03-11,,
+1OTV,2003-03-23,2.1,
+1OTW,2003-03-23,2.3,
+1P9N,2003-05-12,2.8,
+1PN6,2003-06-12,10.8,
+1Q15,2003-07-18,2.3,
+1Q19,2003-07-18,2.4,
+1QZD,2003-09-16,10.0,
+1R2K,2003-09-28,2.1,
+1RDU,2003-11-06,,
+1RP0,2003-12-02,1.6,
+1RZ4,2003-12-23,2.1,
+1S7J,2004-01-29,2.3,
+1SQI,2004-03-18,2.15,
+1SR8,2004-03-22,1.9,
+1TO9,2004-06-14,2.4,
+1TUO,2004-06-25,1.7,
+1TXK,2004-07-05,2.5,
+1TYG,2004-07-07,3.15,
+1U0M,2004-07-13,2.22,
+1UC8,2003-04-09,2.0,
+1UC9,2003-04-09,2.38,
+1UWD,2004-02-03,,
+1VK8,2004-05-05,1.8,
+1VKM,2004-06-09,1.9,
+1VKU,2004-06-18,2.0,
+1VLI,2004-07-27,2.38,
+1VQQ,2004-12-17,1.8,
+1VRM,2005-03-10,1.58,
+1WI8,2004-05-28,,
+1WV2,2004-12-10,2.9,
+1WZU,2005-03-09,2.0,
+1X8D,2004-08-18,1.8,
+1XM3,2004-10-01,1.8,
+1XUA,2004-10-26,1.9,
+1XUB,2004-10-26,1.3,
+1XUU,2004-10-26,1.9,
+1XUZ,2004-10-26,2.2,
+1Y2Y,2004-11-23,,
+1Y5E,2004-12-02,1.9,
+1Z6H,2005-03-22,,
+1ZNN,2005-05-11,2.2,
+2A7K,2005-07-05,2.24,
+2A81,2005-07-07,3.15,
+2APG,2005-08-16,1.9,
+2AQJ,2005-08-18,1.8,
+2AR8,2005-08-19,2.2,
+2ARD,2005-08-19,2.6,
+2AVA,2005-08-29,,
+2B1F,2005-09-15,1.5,
+2B22,2005-09-16,2.0,
+2B8F,2005-10-06,,
+2B8G,2005-10-06,,
+2D3W,2005-10-03,2.5,
+2E8B,2007-01-19,1.61,
+2EDG,2007-02-14,,
+2EEY,2007-02-19,1.94,
+2EKN,2007-03-23,2.05,
+2F1R,2005-11-15,2.1,
+2F98,2005-12-05,2.1,
+2F99,2005-12-05,1.9,
+2FAC,2005-12-07,1.76,
+2FAD,2005-12-07,1.6,
+2FAE,2005-12-07,1.55,
+2FCT,2005-12-12,1.6,
+2FCU,2005-12-12,1.6,
+2FCV,2005-12-12,1.8,
+2FUP,2006-01-27,1.48,
+2FVA,2006-01-30,,
+2FVE,2006-01-30,,
+2FVF,2006-01-30,,
+2G02,2006-02-10,2.5,
+2G0D,2006-02-12,2.21,
+2G4R,2006-02-22,1.92,
+2G5F,2006-02-22,1.8,
+2GRV,2006-04-25,2.4,
+2H3G,2006-05-22,2.0,
+2HES,2006-06-22,1.7,
+2HTM,2006-07-26,2.3,
+2HXV,2006-08-04,1.8,
+2HY6,2006-08-04,1.25,
+2IDE,2006-09-15,1.9,
+2IIH,2006-09-28,1.75,
+2IPZ,2006-10-12,1.35,
+2JDJ,2007-01-10,2.0,
+2JUG,2007-08-24,,
+2K5P,2008-06-30,,
+2KG6,2009-03-06,,
+2KG8,2009-03-06,,
+2KG9,2009-03-07,,
+2KGA,2009-03-07,,
+2KGC,2009-03-08,,
+2KGD,2009-03-08,,
+2KGE,2009-03-08,,
+2KHR,2009-04-10,,
+2L22,2010-08-10,,
+2LEK,2011-06-16,,
+2LRJ,2012-04-03,,
+2M5O,2013-03-01,,
+2MR7,2014-07-02,,
+2MR8,2014-07-02,,
+2MVU,2014-10-15,,
+2MVV,2014-10-15,,
+2N50,2015-07-02,,
+2NQK,2006-10-31,2.9,
+2NQM,2006-10-31,3.0,
+2NQN,2006-10-31,2.2,
+2NQQ,2006-10-31,2.4,
+2NQR,2006-10-31,2.2,
+2NQS,2006-10-31,2.5,
+2NQU,2006-10-31,2.7,
+2NQV,2006-10-31,2.82,
+2NRN,2006-11-02,1.4,
+2NRO,2006-11-02,2.5,
+2NRP,2006-11-02,3.0,
+2NRS,2006-11-02,2.8,
+2O66,2006-12-06,1.9,
+2O67,2006-12-06,2.5,
+2OHD,2007-01-10,2.2,
+2P38,2007-03-08,1.8,
+2P7R,2007-03-20,,
+2PRV,2007-05-04,1.3,
+2PX0,2007-05-14,3.0,
+2PX3,2007-05-14,3.2,
+2PYX,2007-05-16,1.5,
+2Q6I,2007-06-05,2.6,
+2Q6K,2007-06-05,1.55,
+2Q6L,2007-06-05,2.72,
+2Q6O,2007-06-05,2.0,
+2QD2,2007-06-20,2.2,
+2QGM,2007-06-29,1.7,
+2QGO,2007-06-29,2.04,
+2RAD,2007-09-14,2.75,
+2RER,2007-09-26,1.9,
+2RES,2007-09-26,2.2,
+2REZ,2007-09-27,1.95,
+2V7I,2007-07-30,1.75,
+2V7J,2007-07-30,2.0,
+2V7K,2007-07-30,1.7,
+2V7L,2007-07-30,2.4,
+2V7M,2007-07-30,2.0,
+2W6K,2008-12-18,1.7,
+2W6L,2008-12-18,1.89,
+2WFB,2009-04-03,2.0,
+2WMC,2009-06-30,2.2,
+2X0O,2009-12-16,2.4,
+2X0P,2009-12-16,2.1,
+2X0Q,2009-12-16,1.96,
+2X2B,2010-01-12,2.69,
+2X66,2010-02-15,2.09,
+2X67,2010-02-15,2.16,
+2X68,2010-02-15,2.13,
+2X6Q,2010-02-19,2.2,
+2XA1,2010-03-26,2.47,
+2XA2,2010-03-26,2.5,
+2XA9,2010-03-30,2.5,
+2XEM,2010-05-17,2.1,
+2Y4X,2011-01-11,1.7,
+2Y4Y,2011-01-11,1.7,
+2Z2L,2007-05-23,2.85,
+2Z2M,2007-05-23,2.6,
+2Z7E,2007-08-20,2.3,
+2ZC3,2007-11-02,2.5,
+2ZC4,2007-11-02,2.8,
+2ZC5,2007-11-02,3.0,
+2ZC6,2007-11-02,2.7,
+3A3U,2009-06-20,1.65,
+3A8E,2009-10-05,3.0,
+3AJ1,2010-05-20,2.5,
+3AJ2,2010-05-20,2.7,
+3B4O,2007-10-24,1.9,
+3B4P,2007-10-24,1.7,
+3B55,2007-10-25,2.3,
+3B8M,2007-11-01,2.7,
+3B8N,2007-11-01,3.1,
+3B8O,2007-11-01,2.4,
+3BMZ,2007-12-13,1.21,
+3BTN,2007-12-30,2.05,
+3BY5,2008-01-15,2.52,
+3C12,2008-01-22,2.51,
+3CE7,2008-02-28,1.64,
+3CKM,2008-03-16,1.35,
+3CNM,2008-03-26,1.65,
+3CNY,2008-03-26,1.85,
+3CWI,2008-04-21,1.9,
+3DWU,2008-07-23,12.6,
+3DZB,2008-07-29,2.46,
+3DZL,2008-07-30,1.75,
+3EDN,2008-09-03,1.5,
+3EPM,2008-09-29,2.793,
+3EPN,2008-09-29,2.11,
+3EPO,2008-09-29,2.1,
+3EQU,2008-10-01,2.4,
+3EQV,2008-10-01,2.4,
+3EX9,2008-10-16,2.2,
+3EZ9,2008-10-22,2.8,
+3EZF,2008-10-22,2.8,
+3FF0,2008-12-01,1.9,
+3FFE,2008-12-03,2.25,
+3FJS,2008-12-15,1.9,
+3FM0,2008-12-19,1.7,
+3FPZ,2009-01-06,1.82,
+3G2B,2009-01-31,1.66,
+3G3O,2009-02-02,2.1,
+3G3Q,2009-02-02,2.64,
+3G3R,2009-02-02,2.0,
+3G3T,2009-02-02,1.85,
+3G3U,2009-02-02,2.07,
+3G7D,2009-02-09,1.8,
+3G8R,2009-02-12,2.49,
+3GBF,2009-02-19,1.92,
+3GJA,2009-03-08,2.2,
+3GJB,2009-03-08,2.2,
+3GLV,2009-03-12,1.99,
+3GZ7,2009-04-06,2.15,
+3GZL,2009-04-07,2.55,
+3GZM,2009-04-07,1.8,
+3H50,2009-04-21,1.6,
+3H7J,2009-04-27,1.87,
+3H7Y,2009-04-28,2.22,
+3H9A,2009-04-30,2.04,
+3HGU,2009-05-14,1.95,
+3HGV,2009-05-14,2.3,
+3HRQ,2009-06-09,1.8,
+3IAV,2009-07-14,1.75,
+3IB9,2009-07-15,2.0,
+3IBB,2009-07-15,3.5,
+3IEB,2009-07-22,2.1,
+3IX1,2009-09-03,2.4,
+3JQJ,2009-09-07,1.9,
+3JQK,2009-09-07,1.75,
+3JQM,2009-09-07,2.5,
+3JR2,2009-09-08,1.8,
+3JSK,2009-09-10,2.7,
+3JUM,2009-09-15,1.45,
+3JUN,2009-09-15,1.8,
+3JUO,2009-09-15,2.2,
+3JUP,2009-09-15,1.9,
+3JUQ,2009-09-15,1.75,
+3JXP,2009-09-21,2.2,
+3K9G,2009-10-15,2.25,
+3K9H,2009-10-15,2.25,
+3KY8,2009-12-04,2.12,
+3L2K,2009-12-15,2.8,
+3L3B,2009-12-16,1.9,
+3LNV,2010-02-03,2.0,
+3LUU,2010-02-18,1.93,
+3LX3,2010-02-24,1.55,
+3LZC,2010-03-01,2.261,
+3LZD,2010-03-01,2.1,
+3LZE,2010-03-01,1.9,
+3M0N,2010-03-03,1.9,
+3MSQ,2010-04-29,2.85,
+3NGW,2010-06-13,2.31,
+3NNF,2010-06-23,2.201,
+3NNJ,2010-06-23,2.601,
+3NNL,2010-06-23,2.883,
+3NNM,2010-06-23,2.69,
+3O05,2010-07-19,2.2,
+3O06,2010-07-19,2.35,
+3O07,2010-07-19,1.8,
+3O31,2010-07-23,1.7,
+3OI9,2010-08-18,1.95,
+3PL0,2010-11-12,1.91,
+3PZY,2010-12-14,1.8,
+3RFQ,2011-04-06,2.25,
+3T4F,2011-07-25,1.68,
+3TCR,2011-08-09,2.3,
+3TFZ,2011-08-16,2.39,
+3TL1,2011-08-29,1.8,
+3TO3,2011-09-03,2.382,
+3U29,2011-10-02,2.0,
+3WBI,2013-05-20,2.35,
+3WBJ,2013-05-20,2.495,
+3WBK,2013-05-20,3.3,
+3WVQ,2014-06-04,1.955,
+3WVR,2014-06-04,2.175,
+4CT8,2014-03-12,2.16,
+4CT9,2014-03-12,2.14,
+4CTA,2014-03-12,2.21,
+4DUN,2012-02-22,1.76,
+4EXQ,2012-04-30,1.65,
+4FDF,2012-05-28,2.202,
+4FKZ,2012-06-14,1.69,
+4HVM,2012-11-06,2.704,
+4I7U,2012-11-30,1.55,
+4I7V,2012-12-01,1.45,
+4I7W,2012-12-01,1.3,
+4J7G,2013-02-13,1.7,
+4J7H,2013-02-13,1.69,
+4JN3,2013-03-14,1.69,
+4JN5,2013-03-14,2.44,
+4K25,2013-04-08,2.88,
+4K51,2013-04-12,2.65,
+4NAG,2013-10-22,0.81,
+4OYH,2014-02-12,2.409,
+4P2S,2014-03-03,1.94,
+4PNE,2014-05-23,1.5,
+4PYD,2014-03-26,3.186,
+4R0R,2014-08-01,2.15,
+4RHP,2014-10-02,2.393,
+4TWG,2014-06-30,1.85,
+4UUW,2014-07-31,1.98,
+4UUX,2014-07-31,1.99,
+4W4R,2014-08-15,1.92,
+4W4S,2014-08-15,2.0,
+4WD9,2014-09-08,2.9,
+4WJS,2014-10-01,1.8,
+4WJU,2014-10-01,2.8,
+4Y0W,2015-02-06,2.5,
+4Y4L,2015-02-10,2.0,
+4Y4M,2015-02-10,2.71,
+4Y4N,2015-02-10,2.1,
+4YX6,2015-03-22,1.86,
+4ZXH,2015-05-20,2.7,
+4ZXI,2015-05-20,2.9,
+5BY8,2015-06-10,1.515,
+5C05,2015-06-12,1.65,
+5D84,2015-08-15,1.45,
+5D85,2015-08-15,1.92,
+5D86,2015-08-15,1.5,
+5D87,2015-08-15,1.5,
+5D9R,2015-08-18,2.052,
+5EJD,2015-11-01,2.49,
+5EMG,2015-11-06,1.06,
+5EQ7,2015-11-12,1.19,
+5EQ8,2015-11-12,1.3,
+5EQ9,2015-11-12,1.36,
+5EQA,2015-11-12,1.32,
+5GUC,2016-08-28,1.8,
+5GUE,2016-08-28,1.8,
+5GUK,2016-08-29,2.0,
+5GUL,2016-08-29,1.73,
+5H5O,2016-11-08,2.122,
+5H72,2016-11-16,2.4,
+5HTL,2016-01-27,1.371,
+5I2T,2016-02-09,2.543,
+5I47,2016-02-11,2.35,
+5K2M,2016-05-19,2.18,
+5K2Z,2016-05-19,1.8,
+5K3V,2016-05-20,1.9,
+5KCN,2016-06-06,1.965,
+5KSH,2016-07-08,2.4,
+5MWQ,2017-01-19,,
+5NWS,2017-05-08,2.227,
+5O7O,2017-06-09,2.11,
+5O8P,2017-06-14,2.75,
+5O8R,2017-06-14,2.8,
+5ONC,2017-08-03,2.19,
+5OO4,2017-08-05,1.6,
+5OO5,2017-08-05,1.78,
+5OO8,2017-08-06,1.78,
+5OO9,2017-08-06,1.59,
+5OOA,2017-08-06,1.6,
+5T3D,2016-08-25,2.8,
+5T6O,2016-09-01,1.8,
+5T7Z,2016-09-06,2.03,
+5T81,2016-09-06,2.604,
+5VAT,2017-03-27,2.6,
+5VBG,2017-03-29,2.8,
+5W8A,2017-06-21,2.0,
+5W8C,2017-06-21,1.85,
+5W8D,2017-06-21,2.0,
+5W8E,2017-06-21,1.8,
+5W8G,2017-06-21,2.0,
+5W98,2017-06-22,1.23,
+5W99,2017-06-22,1.59,
+5WA3,2017-06-24,2.8,
+5WA4,2017-06-24,2.646,
+5WMM,2017-07-30,2.9,
+5XAV,2017-03-15,1.479,
+5XBJ,2017-03-19,2.448,
+5XT5,2017-06-17,2.34,
+5XT6,2017-06-17,3.5,
+5XW2,2017-06-29,1.298,
+5XW7,2017-06-29,3.272,
+5Y08,2017-07-15,,
+5Y9I,2017-08-25,1.901,
+5Y9X,2017-08-29,1.39,
+5Y9Y,2017-08-29,1.599,
+5YDA,2017-09-12,2.353,
+5YGJ,2017-09-23,2.648,
+5YGK,2017-09-23,2.047,
+5YKA,2017-10-12,1.448,
+5YRP,2017-11-09,2.99,
+5YVZ,2017-11-28,1.6,
+5YW0,2017-11-28,1.49,
+5Z36,2018-01-05,,
+5Z3R,2018-01-08,2.42,
+5Z4E,2018-01-11,,
+5Z4F,2018-01-11,,
+5ZS9,2018-04-28,2.8,
+5ZSK,2018-04-28,3.24,
+5ZSO,2018-04-29,2.7,
+5ZSP,2018-04-29,2.57,
+5ZSQ,2018-04-29,3.211,
+5ZSR,2018-04-29,2.61,
+5ZSS,2018-04-29,3.17,
+5ZST,2018-04-29,3.1,
+5ZT7,2018-05-02,2.94,
+5ZT8,2018-05-02,2.0,
+5ZT9,2018-05-02,2.8,
+5ZTA,2018-05-02,3.07,
+5ZW0,2018-05-14,2.54,
+5ZW2,2018-05-14,1.803,
+5ZW7,2018-05-14,1.3,
+5ZW8,2018-05-14,1.689,
+6A2E,2018-06-11,1.939,
+6A4X,2018-06-21,1.63,
+6A4Z,2018-06-21,1.7,
+6A52,2018-06-21,2.0,
+6A5F,2018-06-23,2.05,
+6A5G,2018-06-23,2.3,
+6A5H,2018-06-23,1.618,
+6A6F,2018-06-27,2.1,
+6AD3,2018-07-30,1.79,
+6AF6,2018-08-08,1.62,
+6AGL,2018-08-13,2.5,
+6AGM,2018-08-13,2.0,
+6AM7,2017-08-09,1.47,
+6AM8,2017-08-09,1.83,
+6AMC,2017-08-09,1.93,
+6AMH,2017-08-09,1.63,
+6AMI,2017-08-09,1.97,
+6AWL,2017-09-05,2.0,
+6BF8,2017-10-26,4.2,
+6BVU,2017-12-13,,
+6BVW,2017-12-14,,
+6BVX,2017-12-14,,
+6BVY,2017-12-14,,
+6BWC,2017-12-14,2.7,
+6BXK,2017-12-18,2.347,
+6BXL,2017-12-18,2.301,
+6BXM,2017-12-18,2.252,
+6BXN,2017-12-18,2.079,
+6BXO,2017-12-18,1.655,
+6C0G,2017-12-31,2.145,
+6C0H,2017-12-31,1.9,
+6C0Y,2018-01-03,1.66,
+6C3A,2018-01-09,1.53,
+6C3B,2018-01-09,1.51,
+6C3C,2018-01-09,1.5,
+6C3D,2018-01-09,1.55,
+6CGO,2018-02-20,2.0,
+6CI7,2018-02-23,2.3,
+6CIB,2018-02-23,2.05,
+6CIV,2018-02-25,,
+6CIX,2018-02-25,,
+6CLW,2018-03-02,2.74,
+6CLX,2018-03-02,2.73,
+6CP3,2018-03-13,3.8,
+6CP5,2018-03-13,4.2,
+6CP6,2018-03-13,3.6,
+6CP7,2018-03-13,4.1,
+6CY8,2018-04-05,2.729,
+6D34,2018-04-14,2.1,
+6D8I,2018-04-26,1.65,
+6D8J,2018-04-26,1.63,
+6DCJ,2018-05-07,1.35,
+6DG6,2018-05-16,1.999,
+6DR3,2018-06-11,2.101,
+6DYM,2018-07-02,2.02,
+6DYN,2018-07-02,2.102,
+6DYO,2018-07-02,2.84,
+6DYR,2018-07-02,2.45,
+6DYS,2018-07-02,2.3,
+6E6U,2018-07-25,1.55,
+6E6Y,2018-07-25,1.6,
+6EC7,2018-08-07,2.15,
+6EC8,2018-08-07,2.148,
+6ESD,2017-10-20,2.6,
+6F9Q,2017-12-15,1.4,
+6FD2,2017-12-21,2.55,
+6FIJ,2018-01-18,2.77,
+6FIK,2018-01-18,7.1,
+6FKO,2018-01-24,2.1,
+6FLF,2018-01-25,1.33,
+6FM0,2018-01-29,1.7,
+6FM1,2018-01-29,2.35,
+6FM3,2018-01-30,1.95,
+6FSQ,2018-02-20,2.79,
+6FT5,2018-02-20,1.94,
+6FTE,2018-02-21,1.52,
+6FW7,2018-03-05,3.0,
+6FW8,2018-03-05,2.4,
+6FW9,2018-03-05,2.739,
+6FWA,2018-03-05,2.846,
+6FXD,2018-03-08,1.45,
+6G2P,2018-03-23,2.6,
+6G56,2018-03-29,2.15,
+6G58,2018-03-29,1.9,
+6G59,2018-03-29,2.45,
+6GE8,2018-04-25,1.869,
+6GHF,2018-05-07,3.52,
+6GJC,2018-05-16,3.3,
+6GMZ,2018-05-29,2.22,
+6GQ3,2018-06-07,1.85,
+6GRG,2018-06-11,2.35,
+6GRH,2018-06-11,1.85,
+6GRI,2018-06-11,2.7,
+6GS2,2018-06-13,2.04,
+6H31,2018-07-17,2.3,
+6H3D,2018-07-18,2.05,
+6H3F,2018-07-18,2.21,
+6H5E,2018-07-24,2.139,
+6HFD,2018-08-21,1.86996804092,
+6HFE,2018-08-21,1.47997437573,
+6HFF,2018-08-21,1.51000106105,
+6HFH,2018-08-21,1.44871265165,
+6HFI,2018-08-21,1.45994719309,
+6HFJ,2018-08-21,1.2,
+6HFK,2018-08-21,1.45914405408,
+6HFL,2018-08-21,1.35,
+6HFN,2018-08-21,1.44965143011,
+6HFP,2018-08-21,1.19822864429,
+6HFQ,2018-08-21,1.14542458871,
+6HFR,2018-08-21,1.29949373933,
+6HFS,2018-08-21,1.34904510922,
+6HFU,2018-08-21,1.39971025955,
+6HG1,2018-08-22,2.12,
+6HG2,2018-08-22,1.83,
+6HG3,2018-08-22,1.97,
+6HK1,2018-09-05,2.55,
+6HNL,2018-09-16,2.2,
+6HNM,2018-09-16,2.0,
+6HNN,2018-09-16,2.7,
+6HQV,2018-09-25,3.0,
+6HS8,2018-09-29,1.7,
+6HS9,2018-09-29,1.05,
+6HSA,2018-09-29,0.92,
+6HSB,2018-09-29,1.95,
+6HSQ,2018-10-01,1.46,
+6HSR,2018-10-01,2.0,
+6HSU,2018-10-01,1.6,
+6HWP,2018-10-12,2.547,
+6I0M,2018-10-26,2.567,
+6I0O,2018-10-26,2.623,
+6I86,2018-11-19,2.0,
+6IHC,2018-09-29,2.4,
+6IPV,2018-11-05,2.2,
+6IPW,2018-11-05,2.1,
+6IUS,2018-11-30,2.12,
+6IX3,2018-12-09,2.13,
+6IX5,2018-12-09,1.7,
+6IX7,2018-12-09,1.835,
+6IX8,2018-12-09,1.659,
+6IX9,2018-12-09,1.776,
+6J0P,2018-12-25,1.79,
+6J1E,2018-12-28,2.4,
+6J1F,2018-12-28,2.1,
+6J1G,2018-12-28,2.5,
+6J1H,2018-12-28,2.101,
+6J1I,2018-12-28,2.29,
+6J1J,2018-12-28,2.0,
+6J1M,2018-12-28,2.001,
+6J1N,2018-12-28,2.532,
+6J31,2019-01-03,2.244,
+6J32,2019-01-03,2.5,
+6JDD,2019-02-01,2.6,
+6JH7,2019-02-17,1.38,
+6JHA,2019-02-17,1.78,
+6JHB,2019-02-17,2.27,
+6JLS,2019-03-06,2.24,
+6JSX,2019-04-08,2.7,
+6JT7,2019-04-10,1.86,
+6JT8,2019-04-10,1.9,
+6JT9,2019-04-10,2.1,
+6JTA,2019-04-10,1.75,
+6JV6,2019-04-16,2.15,
+6JZV,2019-05-04,2.0,
+6JZW,2019-05-04,2.64,
+6K0K,2019-05-07,2.68,
+6K3C,2019-05-17,3.074,
+6K4F,2019-05-23,1.735,
+6KA2,2019-06-20,2.35,
+6KA3,2019-06-20,1.951,
+6KFY,2019-07-09,1.97,
+6KFZ,2019-07-09,1.96,
+6KG0,2019-07-09,2.78,
+6KG1,2019-07-09,2.7,
+6KNH,2019-08-05,1.76,
+6KNI,2019-08-05,1.97,
+6KNK,2019-08-05,2.3,
+6KOG,2019-08-10,1.68,
+6KU3,2019-08-30,2.15,
+6KUN,2019-09-02,2.002,
+6KV9,2019-09-03,1.48,
+6KVC,2019-09-04,1.66,
+6LD7,2019-11-20,2.1,
+6LD8,2019-11-20,2.31,
+6LD9,2019-11-20,2.5,
+6LE0,2019-11-23,2.51,
+6LE3,2019-11-23,2.1,
+6LGO,2019-12-05,2.39,
+6LK3,2019-12-18,2.1,
+6LKC,2019-12-19,1.998,
+6LKZ,2019-12-21,2.8,
+6LTA,2020-01-22,2.45,
+6LTB,2020-01-22,3.1,
+6LTC,2020-01-22,3.3,
+6LTD,2020-01-22,4.1,
+6LV0,2020-02-02,1.998,
+6LVT,2020-02-05,,
+6LVU,2020-02-05,2.294,
+6M03,2020-02-19,2.0,
+6M25,2020-02-26,2.5,
+6M26,2020-02-26,2.61,
+6M27,2020-02-26,2.6,
+6M28,2020-02-26,3.0,
+6M29,2020-02-26,2.9,
+6M2A,2020-02-26,2.23,
+6M2E,2020-02-27,2.6,
+6M2F,2020-02-27,2.4,
+6M2G,2020-02-27,2.8,
+6M2H,2020-02-27,3.1,
+6M2Y,2020-03-02,2.1,
+6M2Z,2020-03-02,2.35,
+6M53,2020-03-09,1.55,
+6M7L,2018-08-20,2.64829708903,
+6M7Y,2018-08-21,2.794,
+6MF9,2018-09-10,2.037,
+6MIC,2018-09-19,1.531,
+6MJF,2018-09-20,2.198,
+6MJG,2018-09-20,2.123,
+6MOE,2018-10-04,2.091,
+6MOF,2018-10-04,2.894,
+6MOG,2018-10-04,1.21,
+6MOH,2018-10-04,3.2,
+6MOI,2018-10-04,2.065,
+6MOJ,2018-10-04,2.431,
+6MOK,2018-10-04,5.101,
+6MOL,2018-10-04,3.163,
+6N04,2018-11-06,1.998,
+6N3P,2018-11-15,2.5,
+6N6Z,2018-11-27,2.642,
+6N70,2018-11-27,2.738,
+6N72,2018-11-27,2.735,
+6N73,2018-11-27,2.398,
+6N74,2018-11-27,1.852,
+6N75,2018-11-27,2.991,
+6N76,2018-11-27,2.892,
+6N9A,2018-12-01,2.5,
+6NCS,2018-12-12,1.8,
+6NEG,2018-12-17,1.95,
+6NEH,2018-12-17,1.52,
+6NEJ,2018-12-17,1.6,
+6NHT,2018-12-23,2.9,
+6NHV,2018-12-24,3.5,
+6NIE,2018-12-27,1.95,
+6NL2,2019-01-07,1.92,
+6NNC,2019-01-14,1.8,
+6NND,2019-01-14,1.7,
+6NNH,2019-01-15,1.523,
+6NNI,2019-01-15,1.561,
+6NOX,2019-01-16,,
+6NR6,2019-01-22,1.9,
+6NSD,2019-01-24,1.74,
+6NVA,2019-02-04,2.16,
+6NW4,2019-02-06,3.0,
+6OBW,2019-03-21,,
+6OC2,2019-03-21,,
+6OC4,2019-03-21,,
+6ODD,2019-03-26,2.0,
+6OHI,2019-04-05,2.27,
+6OHJ,2019-04-05,3.19,
+6OJO,2019-04-11,1.886,
+6OLD,2019-04-16,,
+6OM4,2019-04-18,1.7,
+6OYF,2019-05-14,2.1,
+6OZV,2019-05-16,2.18,
+6P1J,2019-05-20,2.95,
+6P29,2019-05-21,1.5,
+6P3I,2019-05-23,2.15,
+6P4U,2019-05-28,2.1,
+6P5X,2019-05-31,1.97,
+6P5Z,2019-05-31,2.26,
+6P63,2019-05-31,2.4,
+6PBN,2019-06-14,1.65,
+6PBP,2019-06-14,1.64,
+6PBT,2019-06-14,2.18,
+6PD1,2019-06-18,2.72,
+6PD2,2019-06-18,1.95,
+6PE3,2019-06-19,2.3,
+6PEU,2019-06-20,1.95,
+6PH9,2019-06-25,1.92,
+6PIB,2019-06-26,2.26,
+6PJ3,2019-06-27,2.25,
+6PQZ,2019-07-10,2.23,
+6PVF,2019-07-20,1.69,
+6PVG,2019-07-20,1.709,
+6PVH,2019-07-20,1.89,
+6PVI,2019-07-20,2.093,
+6PVJ,2019-07-20,1.25,
+6Q32,2018-12-03,1.39,
+6QSP,2019-02-21,1.45,
+6QSR,2019-02-21,1.85,
+6QTL,2019-02-25,2.25,
+6R2G,2019-03-17,1.9,
+6RM2,2019-05-04,2.5,
+6SBB,2019-07-19,1.95,
+6SBC,2019-07-19,1.35,
+6SBD,2019-07-19,1.4,
+6SBE,2019-07-19,1.4,
+6SBF,2019-07-19,1.3,
+6SBG,2019-07-19,2.3,
+6SM5,2019-08-21,2.75,
+6SME,2019-08-21,1.7,
+6SMF,2019-08-21,2.343,
+6T5X,2019-10-17,1.5,
+6T60,2019-10-17,1.66,
+6T62,2019-10-17,1.8,
+6T65,2019-10-17,2.35,
+6T6N,2019-10-18,2.5,
+6T6P,2019-10-18,1.57,
+6T77,2019-10-21,1.75,
+6T7M,2019-10-22,2.65,
+6TA1,2019-10-29,3.1,
+6TA8,2019-10-29,2.4,
+6TBB,2019-11-01,2.45,
+6TBC,2019-11-01,2.55,
+6TBD,2019-11-01,2.3,
+6TBL,2019-11-01,2.65,
+6TBN,2019-11-01,2.0,
+6TG5,2019-11-15,,
+6THU,2019-11-21,2.6,
+6TIV,2019-11-22,2.38,
+6TJ1,2019-11-23,2.4,
+6TJA,2019-11-25,2.27,
+6TJZ,2019-11-27,2.4,
+6TMS,2019-12-05,2.7,
+6TNH,2019-12-08,2.21,
+6U1Q,2019-08-16,2.87,
+6U24,2019-08-19,,
+6U7Q,2019-09-03,,
+6U7R,2019-09-03,,
+6U7S,2019-09-03,,
+6U7U,2019-09-03,,
+6U7W,2019-09-03,,
+6U7X,2019-09-03,,
+6U8E,2019-09-04,3.03,
+6U8N,2019-09-05,3.29,
+6U8R,2019-09-05,3.91,
+6U8S,2019-09-05,3.14,
+6U9O,2019-09-09,3.36,
+6UA2,2019-09-10,4.2,
+6UA4,2019-09-10,3.65,
+6UA5,2019-09-10,3.79,
+6UAJ,2019-09-10,3.84,
+6UC2,2019-09-13,4.48,
+6UDO,2019-09-19,3.21,
+6UDP,2019-09-19,2.95,
+6UDQ,2019-09-19,3.27,
+6ULU,2019-10-08,2.76,
+6ULW,2019-10-08,3.4,
+6ULX,2019-10-08,2.31,
+6ULY,2019-10-08,2.3,
+6ULZ,2019-10-08,3.1,
+6UVX,2019-11-04,2.3,
+6UW1,2019-11-04,2.205,
+6UW3,2019-11-04,2.4,
+6UW5,2019-11-04,2.2,
+6UW7,2019-11-04,2.342,
+6V1N,2019-11-20,,
+6VAP,2019-12-17,1.93,
+6VHT,2020-01-10,1.84,
+6VHU,2020-01-10,1.6,
+6VHV,2020-01-10,2.89,
+6VHW,2020-01-10,1.83,
+6VHX,2020-01-10,1.7,
+6VHY,2020-01-10,3.0,
+6VHZ,2020-01-10,2.12,
+6VS5,2020-02-10,1.758,
+6VS6,2020-02-10,1.853,
+6VS8,2020-02-10,1.829,
+6VS9,2020-02-10,1.842,
+6VSD,2020-02-11,1.693,
+6VSE,2020-02-11,1.758,
+6VSF,2020-02-11,2.012,
+6VSG,2020-02-11,2.304,
+6VV6,2020-02-17,2.235,
+6VV7,2020-02-17,1.999,
+6VV8,2020-02-17,2.683,
+6VV9,2020-02-17,2.18,
+6VXY,2020-02-25,1.398,
+6VY8,2020-02-25,,
+6VZX,2020-02-28,1.37,
+6W2Q,2020-03-08,1.8,
+6W2R,2020-03-08,2.344,
+6W2V,2020-03-08,2.399,
+6W2W,2020-03-08,2.21,
+6W3D,2020-03-09,1.38,
+6W3F,2020-03-09,1.83,
+6W3G,2020-03-09,1.62,
+6W46,2020-03-10,1.25,
+6W47,2020-03-10,1.15,
+6W9Y,2020-03-24,2.55,
+6W9Z,2020-03-24,2.7,
+6WA0,2020-03-24,3.484,
+6WAO,2020-03-25,1.76,
+6WCS,2020-03-31,1.87,
+6WF4,2020-04-03,1.97,
+6WN3,2020-04-22,1.86,
+6WNB,2020-04-22,2.1,
+6WNC,2020-04-22,2.2,
+6WND,2020-04-22,2.18,
+6WQ1,2020-04-28,2.295,
+6WTD,2020-05-02,4.2,
+6X1I,2020-05-18,4.32,
+6XI9,2020-06-19,2.14,
+6XIG,2020-06-19,1.59,
+6XO2,2020-07-06,1.6,
+6XP8,2020-07-08,1.65,
+6XRC,2020-07-11,2.45,
+6Y3A,2020-02-17,1.49,
+6Y6G,2020-02-26,1.81,
+6Y6I,2020-02-26,1.92,
+6YB8,2020-03-16,2.36,
+6YB9,2020-03-16,2.406,
+6YJE,2020-04-03,1.62,
+6YJF,2020-04-03,1.85,
+6YND,2020-04-13,1.525,
+6YNE,2020-04-13,1.853,
+6YNF,2020-04-13,2.394,
+6YNH,2020-04-13,2.621,
+6YQQ,2020-04-18,2.5,
+6YRU,2020-04-20,1.78,
+6YRV,2020-04-20,1.94,
+6YRX,2020-04-20,1.87,
+6YRZ,2020-04-20,1.824,
+6YS1,2020-04-20,1.64,
+6YS2,2020-04-20,1.97,
+6YSB,2020-04-21,1.2,
+6YTZ,2020-04-25,1.4,
+6YUX,2020-04-27,1.36,
+6YV5,2020-04-27,1.1,
+6YV6,2020-04-27,1.36,
+6Z1K,2020-05-13,1.48,
+6Z1L,2020-05-13,2.29,
+6Z2F,2020-05-15,1.7,
+7ABA,2020-09-07,1.85002316788,
+7ABB,2020-09-07,1.50004339457,
+7AHR,2020-09-25,2.21,
+7AN5,2020-10-11,1.91,
+7AN6,2020-10-11,1.91,
+7AN7,2020-10-11,1.81,
+7AN8,2020-10-11,2.01,
+7AN9,2020-10-11,2.11,
+7B53,2020-12-03,1.75,
+7B60,2020-12-07,1.91,
+7B61,2020-12-07,1.65,
+7B68,2020-12-07,1.89,
+7B6G,2020-12-07,1.937,
+7B6I,2020-12-07,2.069,
+7B6J,2020-12-07,2.09,
+7B6K,2020-12-07,1.838,
+7B6L,2020-12-07,2.08,
+7B6M,2020-12-07,1.67,
+7B6N,2020-12-07,1.79,
+7B6O,2020-12-08,1.86,
+7B6P,2020-12-08,1.68,
+7B6Q,2020-12-08,1.82,
+7B9E,2020-12-14,2.12,
+7B9W,2020-12-14,1.82,
+7BC4,2020-12-18,3.1,
+7BC5,2020-12-18,3.1,
+7BP1,2020-03-21,1.97,
+7BPC,2020-03-22,2.45,
+7BQJ,2020-03-24,1.98,
+7BQK,2020-03-24,1.99,
+7BQL,2020-03-24,2.396,
+7BQO,2020-03-25,1.53,
+7BQP,2020-03-25,1.33,
+7BVD,2020-04-10,1.7,
+7BZV,2020-04-28,1.988,
+7C1H,2020-05-04,2.3,
+7C1K,2020-05-04,2.755,
+7C1L,2020-05-05,1.85,
+7C1P,2020-05-05,2.6,
+7C1R,2020-05-05,1.698,
+7C1S,2020-05-05,2.586,
+7C1U,2020-05-05,1.4,
+7C8M,2020-06-03,3.5,
+7C8N,2020-06-03,1.5,
+7C8O,2020-06-03,1.84,
+7CBB,2020-06-11,2.6,
+7CEO,2020-06-24,2.43,
+7CEP,2020-06-24,2.05,
+7CEQ,2020-06-24,2.0,
+7CER,2020-06-24,2.3,
+7CES,2020-06-24,2.2,
+7CET,2020-06-24,2.64,
+7CEU,2020-06-24,2.9,
+7CFU,2020-06-28,2.15,
+7CGU,2020-07-02,2.4,
+7CJY,2020-07-14,2.2,
+7CNV,2020-08-03,2.23,
+7CPX,2020-08-08,2.91,
+7CPY,2020-08-08,3.6,
+7CRN,2020-08-14,2.26,
+7CXS,2020-09-02,1.83,
+7CXU,2020-09-02,2.19,
+7CXV,2020-09-02,2.35,
+7D68,2020-09-29,3.0,
+7D7O,2020-10-05,1.98,
+7DIB,2020-11-18,2.2,
+7DJX,2020-11-22,1.98,
+7DJY,2020-11-22,2.7,
+7DRD,2020-12-28,2.85,
+7DRE,2020-12-28,2.54,
+7DRY,2020-12-30,1.44,
+7DRZ,2020-12-30,1.7,
+7DS0,2020-12-30,1.69,
+7DS1,2020-12-30,1.58,
+7DUQ,2021-01-11,2.5,
+7DUR,2021-01-11,3.3,
+7DXO,2021-01-19,2.4,
+7E22,2021-02-04,2.63,
+7E37,2021-02-08,2.09,
+7E38,2021-02-08,2.05,
+7E42,2021-02-10,,
+7E4M,2021-02-14,1.57,
+7E4N,2021-02-14,1.94,
+7E4O,2021-02-14,2.5,
+7E5T,2021-02-20,2.1697752983,
+7E5U,2021-02-20,1.62,
+7E5V,2021-02-20,1.61,
+7E6A,2021-02-22,1.96,
+7E6B,2021-02-22,1.84,
+7E6C,2021-02-22,1.73,
+7E6D,2021-02-22,2.67,
+7E6E,2021-02-22,2.28,
+7E6F,2021-02-22,2.74,
+7ED6,2021-03-15,1.92850331296,
+7ED9,2021-03-15,2.01764160944,
+7EHG,2021-03-29,1.95,
+7EKD,2021-04-05,1.899,
+7ETX,2021-05-15,2.1,
+7ETY,2021-05-15,2.21,
+7F8E,2021-07-02,2.08,
+7FC2,2021-07-13,2.0,
+7FE0,2021-07-19,2.2,
+7FE5,2021-07-19,2.09,
+7FH3,2021-07-29,1.8,
+7FH4,2021-07-29,1.996,
+7FH6,2021-07-29,1.55,
+7FH7,2021-07-29,1.42,
+7FH8,2021-07-29,1.32,
+7FH9,2021-07-29,1.9,
+7FHA,2021-07-29,2.0,
+7FJG,2021-08-03,2.72,
+7JSD,2020-08-14,2.5,
+7JTJ,2020-08-17,1.94,
+7JUA,2020-08-19,2.35,
+7JX1,2020-08-26,1.82,
+7JXF,2020-08-27,1.5,
+7K5Z,2020-09-17,1.85,
+7KPQ,2020-11-12,2.1,
+7KPT,2020-11-12,1.91,
+7KVW,2020-11-29,2.18,
+7KW0,2020-11-29,1.9,
+7KW2,2020-11-29,2.0,
+7KW3,2020-11-29,2.3,
+7L2A,2020-12-16,1.85,
+7L2Z,2020-12-17,3.4,
+7L32,2020-12-17,1.9,
+7LL8,2021-02-03,2.31,
+7LL9,2021-02-03,2.9,
+7LLD,2021-02-03,1.4,
+7LM0,2021-02-04,2.09,
+7LXP,2021-03-04,1.4,
+7LXQ,2021-03-04,1.3,
+7LY4,2021-03-05,3.8,
+7LY7,2021-03-05,3.8,
+7M4S,2021-03-22,2.493,
+7MSK,2021-05-11,2.06,
+7MSP,2021-05-11,2.1,
+7N2T,2021-05-29,1.55,
+7N2Y,2021-05-30,2.08,
+7N2Z,2021-05-30,1.29,
+7N79,2021-06-09,1.98,
+7NC1,2021-01-28,2.6,
+7NC2,2021-01-28,1.7,
+7NC3,2021-01-28,1.65,
+7NC5,2021-01-28,1.95,
+7NC6,2021-01-28,2.1,
+7NC8,2021-01-28,2.2,
+7NC9,2021-01-28,2.55,
+7NCB,2021-01-28,1.85,
+7NCD,2021-01-28,2.05,
+7NCE,2021-01-28,2.0,
+7NCL,2021-01-29,2.0,
+7NCM,2021-01-29,1.7,
+7NCN,2021-01-29,1.9,
+7NCO,2021-01-29,1.7,
+7NCP,2021-01-29,2.05,
+7NCT,2021-01-29,2.65,
+7NCU,2021-01-29,1.5,
+7NXG,2021-03-18,1.95,
+7O1D,2021-03-29,1.8,
+7OC4,2021-04-26,2.03,
+7OC5,2021-04-26,2.01,
+7OC6,2021-04-26,2.01,
+7OV7,2021-06-14,1.8,
+7OW9,2021-06-17,1.8,
+7OWB,2021-06-17,2.45,
+7OY1,2021-06-23,2.39,
+7PD7,2021-08-04,1.96,
+7PG7,2021-08-13,1.51,
+7PGA,2021-08-13,2.77,
+7PGJ,2021-08-14,2.13,
+7PHD,2021-08-17,1.53,
+7PHE,2021-08-17,2.32,
+7PHF,2021-08-17,2.21,
+7Q4F,2021-10-30,2.15,
+7Q4G,2021-10-30,1.82,
+7Q9E,2021-11-12,1.7,
+7QCW,2021-11-25,2.81,
+7QTD,2022-01-14,1.75,
+7QTE,2022-01-14,1.81,
+7QTF,2022-01-14,1.55,
+7QTG,2022-01-14,2.695,
+7QUJ,2022-01-18,1.85,
+7QV0,2022-01-19,2.49,
+7QZJ,2022-01-31,1.55,
+7R9X,2021-06-29,2.14,
+7RF9,2021-07-13,1.926,
+7RFA,2021-07-14,,
+7RGB,2021-07-14,2.5,
+7RK0,2021-07-21,2.28,
+7RNP,2021-07-29,2.25,
+7RNQ,2021-07-29,2.102,
+7ROF,2021-07-30,2.39,
+7RTY,2021-08-16,1.963,
+7S2X,2021-09-04,2.85,
+7S3J,2021-09-07,1.94,
+7S3T,2021-09-08,1.4,
+7S5L,2021-09-10,1.58,
+7S6B,2021-09-13,2.35,
+7S6C,2021-09-13,3.1,
+7S6D,2021-09-13,3.1,
+7SCP,2021-09-28,1.99,
+7SU4,2021-11-16,1.78,
+7SU6,2021-11-16,2.15,
+7SU7,2021-11-16,2.09,
+7SU8,2021-11-16,2.65,
+7SZE,2021-11-27,1.74,
+7SZF,2021-11-27,1.79,
+7SZG,2021-11-27,2.69,
+7SZH,2021-11-27,1.79,
+7TCR,2021-12-28,2.62,
+7TCU,2021-12-28,2.31,
+7TCW,2021-12-28,2.67,
+7TCX,2021-12-28,2.21,
+7TE8,2022-01-04,1.998,
+7TFD,2022-01-06,3.16,
+7TFE,2022-01-06,2.85,
+7TWA,2022-02-07,1.7,
+7TYB,2022-02-11,2.11,
+7TZ4,2022-02-15,1.69,
+7TZP,2022-02-16,2.6,
+7U5S,2022-03-02,4.16,
+7U5T,2022-03-02,3.43,
+7U5U,2022-03-02,3.16,
+7U6H,2022-03-04,2.0,
+7U6I,2022-03-04,2.05,
+7U6J,2022-03-04,1.9,
+7UK4,2022-03-31,1.94,
+7ULB,2022-04-04,2.49,
+7ULG,2022-04-04,1.57,
+7ULQ,2022-04-05,2.2,
+7ULR,2022-04-05,1.8,
+7ULS,2022-04-05,1.8,
+7UQL,2022-04-19,1.9,
+7UQM,2022-04-19,1.8,
+7UQN,2022-04-19,1.7,
+7UQO,2022-04-19,1.75,
+7UWR,2022-05-03,2.61,
+7V1Q,2021-08-05,1.58,
+7V1R,2021-08-05,2.81,
+7VIL,2021-09-27,,
+7VO4,2021-10-12,2.1,
+7VO5,2021-10-12,2.4,
+7VOB,2021-10-13,2.09224113188,
+7VSU,2021-10-27,3.1,
+7VSW,2021-10-27,3.0,
+7VUC,2021-11-02,1.4,
+7VUR,2021-11-04,1.7,
+7VUT,2021-11-04,1.7,
+7W5E,2021-11-30,1.65,
+7W85,2021-12-07,2.94,
+7WCC,2021-12-19,1.5,
+7WGH,2021-12-28,2.36,
+7WGI,2021-12-28,2.5,
+7WIY,2022-01-05,3.09,
+7WJ6,2022-01-05,2.55,
+7WJ7,2022-01-05,2.55,
+7WKC,2022-01-08,,
+7WKQ,2022-01-10,2.89,
+7WUP,2022-02-09,2.3,
+7WUW,2022-02-09,1.75,
+7WUX,2022-02-09,1.8,
+7WUY,2022-02-09,1.84,
+7WVS,2022-02-11,2.35,
+7WW0,2022-02-12,1.85,
+7WWF,2022-02-12,2.27,
+7WZV,2022-02-19,1.89931293521,
+7WZX,2022-02-19,1.98001304567,
+7X0B,2022-02-21,2.02027524648,
+7X0E,2022-02-22,2.1,
+7X0F,2022-02-22,2.2,
+7X17,2022-02-23,2.5,
+7X2N,2022-02-25,1.72,
+7X2S,2022-02-26,1.92,
+7X2X,2022-02-26,1.58,
+7X36,2022-02-28,1.92,
+7X4L,2022-03-02,2.59,
+7X4R,2022-03-03,2.6,
+7X4Y,2022-03-03,1.9,
+7X51,2022-03-03,2.0,
+7X52,2022-03-03,1.9,
+7XBS,2022-03-22,1.64,
+7XBT,2022-03-22,1.84,
+7XBU,2022-03-22,2.35,
+7XBV,2022-03-22,1.94,
+7XDQ,2022-03-28,2.83,
+7XDR,2022-03-28,2.4,
+7XEJ,2022-03-31,1.74,
+7XEK,2022-03-31,1.88,
+7XEL,2022-03-31,1.8,
+7XEN,2022-03-31,2.47,
+7XEP,2022-03-31,1.78,
+7XEQ,2022-03-31,2.9,
+7XES,2022-03-31,3.0,
+7XET,2022-03-31,2.3,
+7XKX,2022-04-20,2.57,
+7XMU,2022-04-26,2.3,
+7XMV,2022-04-27,2.6,
+7XN3,2022-04-27,2.9,
+7XND,2022-04-28,1.6,
+7XQ4,2022-05-06,1.58,
+7XQM,2022-05-08,2.71,
+7XQN,2022-05-08,1.98,
+7XQZ,2022-05-09,2.0,
+7XR7,2022-05-09,1.63,
+7XRA,2022-05-09,1.95,
+7XRU,2022-05-11,2.5,
+7XSI,2022-05-14,2.7,
+7Y3H,2022-06-10,1.97,
+7Y50,2022-06-16,2.0,
+7Y87,2022-06-23,2.3,
+7Y88,2022-06-23,1.87,
+7YB3,2022-06-28,1.8,
+7YGF,2022-07-11,2.08,
+7YKC,2022-07-22,3.3,
+7YNU,2022-08-01,1.44,
+7YNV,2022-08-01,1.39,
+7YQM,2022-08-08,2.89,
+7YQN,2022-08-08,1.6,
+7YUA,2022-08-16,2.5,
+7YV0,2022-08-18,2.34,
+7YVV,2022-08-19,2.1,
+7YWC,2022-02-12,1.917,
+7ZM9,2022-04-19,1.62,
+7ZMA,2022-04-19,2.9,
+7ZMC,2022-04-19,3.1,
+7ZMD,2022-04-19,2.93,
+7ZMF,2022-04-19,2.21,
+7ZP5,2022-04-26,1.54,
+7ZP6,2022-04-26,1.9,
+7ZP7,2022-04-26,1.7,
+7ZSK,2022-05-07,6.8,
+8A0C,2022-05-27,2.9,
+8A0M,2022-05-29,3.6,
+8A6U,2022-06-20,1.65,
+8A6V,2022-06-20,1.9,
+8A6Z,2022-06-20,2.4,
+8A70,2022-06-20,2.1,
+8A73,2022-06-20,1.6,
+8A74,2022-06-20,1.9,
+8A78,2022-06-20,1.6,
+8A7A,2022-06-20,1.6,
+8A7B,2022-06-20,1.65,
+8A7C,2022-06-20,1.2,
+8A7J,2022-06-21,1.2,
+8A7K,2022-06-21,1.3,
+8A7L,2022-06-21,1.85,
+8A7R,2022-06-21,2.0,
+8A7U,2022-06-21,1.55,
+8A82,2022-06-21,2.05,
+8A8E,2022-06-22,2.9,
+8AHQ,2022-07-22,2.1,
+8AHZ,2022-07-25,1.7,
+8AJA,2022-07-27,2.59,
+8AJL,2022-07-28,2.77,
+8AW4,2022-08-29,2.21,
+8AYB,2022-09-02,1.8,
+8AYD,2022-09-02,2.8,
+8BCM,2022-10-17,2.15,
+8BP0,2022-11-15,2.621,
+8BP1,2022-11-15,1.72,
+8BTM,2022-11-29,1.4,
+8BY8,2022-12-12,2.5,
+8BYK,2022-12-13,1.7,
+8BYR,2022-12-21,2.53,
+8C0T,2022-12-19,1.28,
+8C3W,2022-12-29,1.6,
+8CAR,2023-01-24,2.68,
+8CAV,2023-01-24,2.87,
+8CG4,2023-02-03,2.6,
+8CG5,2023-02-03,2.7,
+8CG6,2023-02-03,3.4,
+8CJH,2023-02-13,2.982,
+8COP,2023-02-28,1.8,
+8COQ,2023-02-28,1.7,
+8COW,2023-03-01,1.6,
+8COX,2023-03-01,2.1,
+8CQ8,2023-03-04,1.8,
+8CQ9,2023-03-04,1.75,
+8CQA,2023-03-04,2.0,
+8CUY,2022-05-17,2.4,
+8CUZ,2022-05-17,3.0,
+8CV0,2022-05-17,3.1,
+8CV1,2022-05-17,2.6,
+8CWX,2022-05-19,,
+8CXL,2022-05-21,1.98,
+8CZC,2022-05-24,2.86,
+8D8S,2022-06-08,1.388,
+8DAJ,2022-06-13,1.2,
+8DEB,2022-06-20,1.94,
+8DL5,2022-07-06,2.1,
+8E2U,2022-08-16,3.48,
+8E4A,2022-08-17,2.034,
+8EAY,2022-08-30,3.33,
+8EBP,2022-08-31,3.38,
+8EGY,2022-09-13,2.05,
+8EGZ,2022-09-13,1.9,
+8EH0,2022-09-13,1.7,
+8EH1,2022-09-13,2.0,
+8EO9,2022-10-02,,
+8EQW,2022-10-10,1.76,
+8ERB,2022-10-11,1.98,
+8ERJ,2022-10-12,2.16,
+8ES6,2022-10-13,1.9,
+8F7F,2022-11-18,1.62,
+8F7G,2022-11-18,2.4,
+8F7H,2022-11-18,1.93,
+8F7I,2022-11-18,1.58,
+8FBC,2022-11-29,1.53,
+8FBZ,2022-11-30,1.59,
+8FFT,2022-12-10,2.1,
+8FFU,2022-12-10,2.04,
+8FHJ,2022-12-14,2.61,
+8FTR,2023-01-13,2.13,
+8FTS,2023-01-13,2.2,
+8FTV,2023-01-13,2.04,
+8FX6,2023-01-24,2.2,
+8FX7,2023-01-24,2.2,
+8G3I,2023-02-08,3.02,
+8G3J,2023-02-08,2.1,
+8G4U,2023-02-10,2.9,
+8G5S,2023-02-14,1.5,
+8G5T,2023-02-14,1.846,
+8G5U,2023-02-14,1.804,
+8G7W,2023-02-17,3.4,
+8G8K,2023-02-18,1.54,
+8GS1,2022-09-04,2.7,
+8GSA,2022-09-05,,
+8GSM,2022-09-06,2.88,
+8GX4,2022-09-18,1.97007775894,
+8GY0,2022-09-21,1.988,
+8GYH,2022-09-22,1.8,
+8GYI,2022-09-22,1.93,
+8GYJ,2022-09-22,1.82,
+8GZI,2022-09-27,2.12209677016,
+8H2C,2022-10-05,2.9,
+8H4H,2022-10-10,2.3,
+8H4J,2022-10-10,2.0,
+8H4Q,2022-10-11,2.22,
+8H4Z,2022-10-11,2.2,
+8H50,2022-10-11,2.9,
+8H52,2022-10-11,3.1,
+8H8I,2022-10-22,2.03,
+8HAR,2022-10-26,2.12,
+8HBT,2022-10-31,1.96,
+8HCI,2022-11-01,3.399,
+8HCZ,2022-11-03,1.48,
+8HD2,2022-11-03,1.6,
+8HD4,2022-11-03,2.68,
+8HDF,2022-11-04,2.24,
+8HHI,2022-11-16,1.4,
+8HK0,2022-11-24,2.29,
+8HYR,2023-01-07,2.55,
+8HZV,2023-01-09,2.33001676063,
+8HZY,2023-01-10,2.03978804974,
+8I1M,2023-01-13,1.699,
+8I1N,2023-01-13,2.8,
+8I1O,2023-01-13,2.4,
+8I29,2023-01-14,2.72,
+8I55,2023-01-24,1.99,
+8I56,2023-01-24,2.84,
+8I57,2023-01-24,2.81,
+8I58,2023-01-24,3.09,
+8I5Z,2023-01-26,2.65,
+8IF7,2023-02-17,2.2,
+8IH6,2023-02-22,2.519,
+8IH7,2023-02-22,2.48,
+8IHG,2023-02-22,2.858,
+8IL0,2023-03-01,2.81,
+8ILA,2023-03-03,2.79,
+8IS2,2023-03-20,1.32,
+8IYU,2023-04-06,2.1,
+8J0A,2023-04-10,3.0,
+8J3G,2023-04-16,2.3,
+8J3I,2023-04-16,2.39,
+8J59,2023-04-21,1.55,
+8JF9,2023-05-17,1.9,
+8JFA,2023-05-17,2.55,
+8JFG,2023-05-18,2.83,
+8JFH,2023-05-18,1.8,
+8JFI,2023-05-18,2.38,
+8JFJ,2023-05-18,1.8,
+8JFM,2023-05-18,2.21,
+8JFN,2023-05-18,2.41,
+8JG2,2023-05-19,1.64,
+8JG3,2023-05-19,2.0,
+8JG7,2023-05-19,2.85,
+8JMQ,2023-06-05,2.0,
+8JMR,2023-06-05,2.2,
+8JON,2023-06-07,2.51,
+8K04,2023-07-07,2.72,
+8K0A,2023-07-07,3.12,
+8K1X,2023-07-11,2.27,
+8KI5,2023-08-22,2.01,
+8KIH,2023-08-23,2.0,
+8ODW,2023-03-09,3.07,
+8OOM,2023-04-05,1.82,
+8OSV,2023-04-20,1.28,
+8OSZ,2023-04-20,1.26,
+8OT2,2023-04-20,1.77,
+8P23,2023-05-14,3.17,
+8P27,2023-05-15,2.73,
+8P2C,2023-05-15,2.59,
+8P2D,2023-05-15,2.59,
+8P2S,2023-05-16,2.4,
+8P37,2023-05-17,1.219,
+8P39,2023-05-17,2.58,
+8P4Q,2023-05-23,1.88,
+8P5O,2023-05-24,2.6,
+8PR9,2023-07-12,2.35,
+8PRA,2023-07-12,2.05,
+8PRB,2023-07-12,1.8,
+8PRC,2023-07-12,2.35,
+8PRD,2023-07-12,1.41,
+8PRE,2023-07-12,3.1,
+8PRF,2023-07-12,2.8,
+8PRG,2023-07-12,2.35,
+8PRH,2023-07-12,1.6,
+8PRI,2023-07-12,2.1,
+8PRJ,2023-07-12,1.4,
+8PRL,2023-07-12,2.65,
+8PRM,2023-07-12,2.2,
+8PRO,2023-07-12,1.7,
+8PRP,2023-07-12,2.82,
+8PRQ,2023-07-12,1.46,
+8PRR,2023-07-12,1.32,
+8PRS,2023-07-12,1.75,
+8PRT,2023-07-12,1.65,
+8PT4,2023-07-13,3.33,
+8PVG,2023-07-17,3.4,
+8QHE,2023-09-07,1.6,
+8QIJ,2023-09-12,2.073,
+8QNF,2023-09-26,1.65,
+8QOY,2023-09-29,3.0,
+8QPY,2023-10-03,,
+8QRX,2023-10-09,,
+8QSX,2023-10-11,,
+8QWD,2023-10-19,3.33,
+8QWE,2023-10-19,3.14,
+8QWF,2023-10-19,3.08,
+8QWJ,2023-10-19,1.5,
+8QZU,2023-10-30,1.18,
+8R20,2023-11-02,2.1,
+8R2B,2023-11-03,1.8,
+8R2E,2023-11-04,2.0,
+8R2J,2023-11-06,2.4,
+8RA0,2023-11-30,1.89,
+8RZ6,2024-02-12,2.3,
+8SAM,2023-04-01,2.15,
+8SAO,2023-04-01,2.502,
+8SAP,2023-04-01,2.52,
+8SKJ,2023-04-19,2.01,
+8SMS,2023-04-26,1.93,
+8STB,2023-05-09,2.22,
+8SUE,2023-05-12,3.5,
+8SW5,2023-05-17,2.39,
+8SW6,2023-05-17,1.76,
+8T19,2023-06-02,1.23,
+8T7J,2023-06-20,2.4,
+8TB1,2023-06-28,,
+8TJI,2023-07-22,1.73,
+8TJJ,2023-07-22,1.82,
+8TJK,2023-07-22,1.85,
+8TJP,2023-07-23,3.71,
+8TKO,2023-07-25,3.05,
+8TN2,2023-08-01,1.75,
+8TN3,2023-08-01,1.63,
+8TPW,2023-08-05,3.46,
+8TPX,2023-08-05,3.4,
+8TQG,2023-08-07,2.2,
+8TQV,2023-08-08,2.0,
+8TR4,2023-08-09,2.1,
+8TRY,2023-08-10,2.35,
+8TW0,2023-08-18,1.53,
+8TXY,2023-08-24,2.1,
+8U05,2023-08-28,1.62,
+8U06,2023-08-28,1.6,
+8U07,2023-08-28,1.63,
+8U7J,2023-09-15,3.02,
+8U9E,2023-09-19,3.02,
+8UZ2,2023-11-14,3.18,
+8V1X,2023-11-21,1.84,
+8VAD,2023-12-11,1.45,
+8W6Z,2023-08-30,2.2,
+8W72,2023-08-30,3.25,
+8WD5,2023-09-14,2.8,
+8WGI,2023-09-21,,
+8WGJ,2023-09-21,,
+8WU6,2023-10-20,1.81,
+8WU7,2023-10-20,2.09,
+8WVR,2023-10-24,2.05,
+8WWW,2023-10-27,2.78,
+8X0U,2023-11-06,2.65,
+8X0V,2023-11-06,2.4,
+8X1W,2023-11-09,2.1,
+8X3E,2023-11-13,2.5,
+8X3X,2023-11-14,2.15,
+8X3Y,2023-11-14,2.15,
+8X3Z,2023-11-14,2.75,
+8XBO,2023-12-06,2.53,
+8XBQ,2023-12-06,2.05,
+8XBR,2023-12-06,1.92,
+8XOD,2024-01-01,2.75,
+8XTE,2024-01-10,1.99,
+8XTF,2024-01-10,2.13,
+8XTG,2024-01-10,2.0,
+8Y54,2024-01-31,1.78,
+8YL9,2024-03-05,2.75,
+8YLA,2024-03-05,1.3,
+8YLZ,2024-03-07,1.6,
+8YT4,2024-03-24,1.42,
+8YZN,2024-04-07,1.799,
+8YZO,2024-04-07,1.769,
+8Z5C,2024-04-18,1.85,
+8Z5D,2024-04-18,2.5,
+8Z5E,2024-04-18,2.2,
+8Z5F,2024-04-18,1.95,
+8ZQA,2024-06-01,2.91,
+8ZTP,2024-06-07,3.2,
+8ZTQ,2024-06-07,2.889,
+9AZA,2024-03-10,2.84,
+9AZB,2024-03-11,2.9,
+9B0C,2024-03-11,1.66,
+9B6C,2024-03-25,3.35,
+9BE3,2024-04-13,2.9,
+9BE4,2024-04-13,3.0,
+9BFG,2024-04-17,2.18,
+9BHN,2024-04-21,,
+9BYU,2024-05-24,1.75,
+9CEN,2024-06-26,1.8,
+9CJX,2024-07-08,,
+9DK2,2024-09-07,2.5,
+9DK3,2024-09-07,2.3,
+9F48,2024-04-26,3.4,
+9FCK,2024-05-15,3.8,
+9FMH,2024-06-06,0.9,
+9FMI,2024-06-06,0.9,
+9FMJ,2024-06-06,0.95,
+9FMK,2024-06-06,1.01,
+9JA1,2024-08-23,2.98,
+9JVA,2024-10-08,2.08,
+9JWC,2024-10-10,2.08,
+9K71,2024-10-23,2.28,
+9KAU,2024-10-29,1.88,
+1OQM,2003-03-10,2.1,
+1RF8,2003-11-07,,
+1Y13,2004-11-17,2.2,
+1Z5Y,2005-03-21,1.94,
+1ZM2,2005-05-10,3.07,
+1ZM3,2005-05-10,3.07,
+1ZM4,2005-05-10,2.9,
+1ZM9,2005-05-10,2.8,
+1ZUD,2005-05-30,1.98,
+2A0S,2005-06-16,2.2,
+2E4G,2006-12-07,2.08,
+2EY4,2005-11-09,2.11,
+2FHS,2005-12-27,2.7,
+2H84,2006-06-06,2.9,
+2O9Z,2006-12-14,2.494,
+2OA1,2006-12-14,2.15,
+2OAL,2006-12-16,2.1,
+2OAM,2006-12-16,2.3,
+2ZIT,2008-02-24,3.0,
+3B78,2007-10-30,2.5,
+3B82,2007-10-31,2.35,
+3B8H,2007-11-01,2.5,
+3BM5,2007-12-12,2.4,
+3D2O,2008-05-08,2.04,
+3F4N,2008-11-01,2.402,
+3FEM,2008-11-30,3.02,
+3FPE,2009-01-05,1.7,
+3FPF,2009-01-05,1.66,
+3FPG,2009-01-05,2.0,
+3FPH,2009-01-05,1.8,
+3FPJ,2009-01-05,1.8,
+3ORQ,2010-09-07,2.23,
+3ORR,2010-09-07,2.23,
+3ORS,2010-09-07,1.45,
+3R74,2011-03-22,2.9,
+3R75,2011-03-22,2.1,
+3R76,2011-03-22,2.6,
+4F7W,2012-05-16,2.1,
+4KEH,2013-04-25,1.901,
+4KQO,2013-05-15,2.31,
+4KQQ,2013-05-15,2.1,
+4KQR,2013-05-15,2.01,
+4N6E,2013-10-11,2.6,
+4ZJB,2015-04-29,2.55,
+5EIN,2015-10-30,1.7,
+5EIO,2015-10-30,1.8,
+5K95,2016-05-31,2.77,
+5K9G,2016-05-31,1.9,
+5W6Y,2017-06-18,1.995,
+6P2I,2019-05-21,1.63,
+6PBM,2019-06-14,1.57,
+6PPW,2019-07-08,1.85,
+6PPX,2019-07-08,1.85,
+6PPY,2019-07-08,2.0,
+6PPZ,2019-07-08,2.4,
+6XGS,2020-06-18,2.2,
+7FE6,2021-07-19,2.5,
+7K34,2020-09-10,1.66,
+7KH2,2020-10-19,2.05,
+7KZ3,2020-12-09,1.55,
+7KZ5,2020-12-10,1.6,
+7KZ6,2020-12-10,1.65,
+7KZD,2020-12-10,1.9,
+7LVO,2021-02-26,2.0,
+7LVP,2021-02-26,2.24,
+7LY5,2021-03-05,2.5,
+7M0O,2021-03-11,1.62,
+7RC6,2021-07-07,1.71,
+7TF6,2022-01-06,2.15,
+7TF7,2022-01-06,2.13,
+7TF9,2022-01-06,2.61,
+7TFA,2022-01-06,2.07,
+7TFB,2022-01-06,2.28,
+7TFC,2022-01-06,1.96,
+7VUS,2021-11-04,1.7,
+7VUU,2021-11-04,1.95,
+8EPY,2022-10-06,,
+8EWU,2022-10-24,1.45,
+1RRZ,2003-12-09,,
+1WU2,2004-11-30,2.3,
+1ZN0,2005-05-11,15.5,
+2FU3,2006-01-25,2.7,
+2HQT,2006-07-19,1.9,
+2HVY,2006-07-31,2.3,
+2ZU0,2008-10-11,2.2,
+3HAX,2009-05-03,2.11,
+3HAY,2009-05-03,4.99,
+3IE5,2009-07-22,1.688,
+4PD0,2014-04-17,1.7,
+4TK1,2014-05-25,2.7,
+4TK2,2014-05-25,4.1,
+4TK3,2014-05-25,2.7,
+4TK4,2014-05-25,3.601,
+6DG5,2018-05-16,2.516,
+6NDZ,2018-12-14,2.264,
+6NE1,2018-12-15,3.011,
+6NE2,2018-12-15,1.299,
+6NE4,2018-12-16,1.648,
+7M7E,2021-03-28,3.2,
+7M7F,2021-03-28,3.2,
+7M7G,2021-03-28,4.1,
+7M7H,2021-03-28,4.1,
+7M7I,2021-03-28,3.4,
+7M7J,2021-03-28,4.3,
+8TJN,2023-07-23,3.73,
+8TJO,2023-07-23,3.61,
+8EE0,2022-09-06,2.65,
+8EE1,2022-09-06,2.7,
diff --git a/notebooks/biosynthetic_protein_pdb_report_deposition_date.png b/notebooks/biosynthetic_protein_pdb_report_deposition_date.png
new file mode 100644
index 00000000..ca5df796
Binary files /dev/null and b/notebooks/biosynthetic_protein_pdb_report_deposition_date.png differ
diff --git a/notebooks/biosynthetic_protein_pdb_report_resolution.png b/notebooks/biosynthetic_protein_pdb_report_resolution.png
new file mode 100644
index 00000000..6f31fb46
Binary files /dev/null and b/notebooks/biosynthetic_protein_pdb_report_resolution.png differ
diff --git a/notebooks/casp15_all_multi_ligand_relaxed_lddt_pli_violin_plot.png b/notebooks/casp15_all_multi_ligand_relaxed_lddt_pli_violin_plot.png
new file mode 100644
index 00000000..6a8e154d
Binary files /dev/null and b/notebooks/casp15_all_multi_ligand_relaxed_lddt_pli_violin_plot.png differ
diff --git a/notebooks/casp15_all_multi_ligand_relaxed_pb_valid_bar_chart.png b/notebooks/casp15_all_multi_ligand_relaxed_pb_valid_bar_chart.png
new file mode 100644
index 00000000..32dbd62e
Binary files /dev/null and b/notebooks/casp15_all_multi_ligand_relaxed_pb_valid_bar_chart.png differ
diff --git a/notebooks/casp15_all_multi_ligand_relaxed_rmsd_lt2_bar_chart.png b/notebooks/casp15_all_multi_ligand_relaxed_rmsd_lt2_bar_chart.png
new file mode 100644
index 00000000..3ba56d9a
Binary files /dev/null and b/notebooks/casp15_all_multi_ligand_relaxed_rmsd_lt2_bar_chart.png differ
diff --git a/notebooks/casp15_all_multi_ligand_relaxed_rmsd_violin_plot.png b/notebooks/casp15_all_multi_ligand_relaxed_rmsd_violin_plot.png
new file mode 100644
index 00000000..5c221401
Binary files /dev/null and b/notebooks/casp15_all_multi_ligand_relaxed_rmsd_violin_plot.png differ
diff --git a/notebooks/casp15_all_single_ligand_relaxed_lddt_pli_violin_plot.png b/notebooks/casp15_all_single_ligand_relaxed_lddt_pli_violin_plot.png
new file mode 100644
index 00000000..0cb19554
Binary files /dev/null and b/notebooks/casp15_all_single_ligand_relaxed_lddt_pli_violin_plot.png differ
diff --git a/notebooks/casp15_all_single_ligand_relaxed_pb_valid_bar_chart.png b/notebooks/casp15_all_single_ligand_relaxed_pb_valid_bar_chart.png
new file mode 100644
index 00000000..8307cf2f
Binary files /dev/null and b/notebooks/casp15_all_single_ligand_relaxed_pb_valid_bar_chart.png differ
diff --git a/notebooks/casp15_all_single_ligand_relaxed_rmsd_lt2_bar_chart.png b/notebooks/casp15_all_single_ligand_relaxed_rmsd_lt2_bar_chart.png
new file mode 100644
index 00000000..dce2899d
Binary files /dev/null and b/notebooks/casp15_all_single_ligand_relaxed_rmsd_lt2_bar_chart.png differ
diff --git a/notebooks/casp15_all_single_ligand_relaxed_rmsd_violin_plot.png b/notebooks/casp15_all_single_ligand_relaxed_rmsd_violin_plot.png
new file mode 100644
index 00000000..3e55984a
Binary files /dev/null and b/notebooks/casp15_all_single_ligand_relaxed_rmsd_violin_plot.png differ
diff --git a/notebooks/casp15_inference_results_plotting.ipynb b/notebooks/casp15_inference_results_plotting.ipynb
index 3d70891d..f964c1c3 100644
--- a/notebooks/casp15_inference_results_plotting.ipynb
+++ b/notebooks/casp15_inference_results_plotting.ipynb
@@ -76,6 +76,8 @@
" \"rfaa\",\n",
" \"chai-lab_ss\",\n",
" \"chai-lab\",\n",
+ " \"boltz_ss\",\n",
+ " \"boltz\",\n",
" \"alphafold3_ss\",\n",
" \"alphafold3\",\n",
"]\n",
@@ -90,6 +92,8 @@
" \"rfaa\": \"RFAA\",\n",
" \"chai-lab_ss\": \"Chai-1-Single-Seq\",\n",
" \"chai-lab\": \"Chai-1\",\n",
+ " \"boltz_ss\": \"Boltz-1-Single-Seq\",\n",
+ " \"boltz\": \"Boltz-1\",\n",
" \"alphafold3_ss\": \"AF3-Single-Seq\",\n",
" \"alphafold3\": \"AF3\",\n",
"}\n",
@@ -102,6 +106,8 @@
" \"rfaa\": \"DL-based blind\",\n",
" \"chai-lab_ss\": \"DL-based blind\",\n",
" \"chai-lab\": \"DL-based blind\",\n",
+ " \"boltz_ss\": \"DL-based blind\",\n",
+ " \"boltz\": \"DL-based blind\",\n",
" \"alphafold3_ss\": \"DL-based blind\",\n",
" \"alphafold3\": \"DL-based blind\",\n",
"}"
@@ -549,7 +555,7 @@
"colors = [\"#FB8072\", \"#BEBADA\", \"#FCCDE5\"]\n",
"\n",
"bar_width = 0.5\n",
- "r1 = [item - 0.5 for item in range(2, 20, 2)]\n",
+ "r1 = [item - 0.5 for item in range(2, 24, 2)]\n",
"r2 = [x + bar_width for x in r1]\n",
"r3 = [x + bar_width for x in r2]\n",
"\n",
@@ -796,7 +802,7 @@
" # add labels, titles, ticks, etc.\n",
" axis.set_xlabel(f\"{complex_type.title()}-ligand blind docking ({complex_license})\")\n",
" axis.set_ylabel(\"Percentage of predictions\")\n",
- " axis.set_xlim(1, 19 + 0.1)\n",
+ " axis.set_xlim(1, 23 + 0.1)\n",
" axis.set_ylim(0, 125)\n",
"\n",
" axis.bar_label(casp15_rmsd_lt2_bar, fmt=\"{:,.1f}\", label_type=\"center\")\n",
@@ -810,7 +816,7 @@
" axis.grid(axis=\"y\", color=\"#EAEFF8\")\n",
" axis.set_axisbelow(True)\n",
"\n",
- " axis.set_xticks([2, 2 + 1e-3, 4, 6, 8, 10, 11, 12, 14, 16, 18])\n",
+ " axis.set_xticks([2, 2 + 1e-3, 4, 6, 8, 10, 12, 13, 14, 16, 18, 20, 22])\n",
" axis.set_xticks([1 + 0.1], minor=True)\n",
" axis.set_xticklabels(\n",
" [\n",
@@ -820,9 +826,11 @@
" \"DynamicBind\",\n",
" \"NeuralPLexer\",\n",
" \"RFAA\",\n",
- " \"DL-based blind\",\n",
" \"Chai-1-Single-Seq\",\n",
+ " \"DL-based blind\",\n",
" \"Chai-1\",\n",
+ " \"Boltz-1-Single-Seq\",\n",
+ " \"Boltz-1\",\n",
" \"AF3-Single-Seq\",\n",
" \"AF3\",\n",
" ]\n",
@@ -836,7 +844,7 @@
" axis.tick_params(axis=\"y\", which=\"major\", left=\"off\", right=\"on\", color=\"#EAEFF8\")\n",
"\n",
" # vertical alignment of xtick labels\n",
- " vert_alignments = [0.0, -0.1, 0.0, 0.0, 0.0, 0.0, -0.1, 0.0, 0.0, 0.0, 0.0]\n",
+ " vert_alignments = [0.0, -0.1, 0.0, 0.0, 0.0, 0.0, 0.0, -0.1, 0.0, 0.0, 0.0, 0.0, 0.0]\n",
" for tick, y in zip(axis.get_xticklabels(), vert_alignments):\n",
" tick.set_y(y)\n",
"\n",
@@ -939,7 +947,7 @@
"colors = [\"#FB8072\", \"#BEBADA\"]\n",
"\n",
"bar_width = 0.75\n",
- "r1 = [item - 0.25 for item in range(2, 20, 2)]\n",
+ "r1 = [item - 0.25 for item in range(2, 24, 2)]\n",
"r2 = [x + bar_width for x in r1]\n",
"\n",
"for complex_type in [\"single\", \"multi\"]:\n",
@@ -1122,7 +1130,7 @@
" # add labels, titles, ticks, etc.\n",
" axis.set_xlabel(f\"{complex_type.title()}-ligand blind docking ({complex_license})\")\n",
" axis.set_ylabel(\"Percentage of complex predictions\")\n",
- " axis.set_xlim(1, 19 + 0.1)\n",
+ " axis.set_xlim(1, 23 + 0.1)\n",
" axis.set_ylim(0, 100)\n",
"\n",
" axis.bar_label(casp15_pb_valid_bar, fmt=\"{:,.1f}\", label_type=\"center\")\n",
@@ -1135,7 +1143,7 @@
" axis.grid(axis=\"y\", color=\"#EAEFF8\")\n",
" axis.set_axisbelow(True)\n",
"\n",
- " axis.set_xticks([2, 2 + 1e-3, 4, 6, 8, 10, 11, 12, 14, 16, 18])\n",
+ " axis.set_xticks([2, 2 + 1e-3, 4, 6, 8, 10, 12, 13, 14, 16, 18, 20, 22])\n",
" axis.set_xticks([1 + 0.1], minor=True)\n",
" axis.set_xticklabels(\n",
" [\n",
@@ -1145,9 +1153,11 @@
" \"DynamicBind\",\n",
" \"NeuralPLexer\",\n",
" \"RFAA\",\n",
- " \"DL-based blind\",\n",
" \"Chai-1-Single-Seq\",\n",
+ " \"DL-based blind\",\n",
" \"Chai-1\",\n",
+ " \"Boltz-1-Single-Seq\",\n",
+ " \"Boltz-1\",\n",
" \"AF3-Single-Seq\",\n",
" \"AF3\",\n",
" ]\n",
@@ -1161,7 +1171,7 @@
" axis.tick_params(axis=\"y\", which=\"major\", left=\"off\", right=\"on\", color=\"#EAEFF8\")\n",
"\n",
" # vertical alignment of xtick labels\n",
- " vert_alignments = [0.0, -0.1, 0.0, 0.0, 0.0, 0.0, -0.1, 0.0, 0.0, 0.0, 0.0]\n",
+ " vert_alignments = [0.0, -0.1, 0.0, 0.0, 0.0, 0.0, 0.0, -0.1, 0.0, 0.0, 0.0, 0.0, 0.0]\n",
" for tick, y in zip(axis.get_xticklabels(), vert_alignments):\n",
" tick.set_y(y)\n",
"\n",
diff --git a/notebooks/casp15_method_interaction_analysis.png b/notebooks/casp15_method_interaction_analysis.png
new file mode 100644
index 00000000..36a58f7f
Binary files /dev/null and b/notebooks/casp15_method_interaction_analysis.png differ
diff --git a/notebooks/casp15_method_interaction_analysis_plotting.ipynb b/notebooks/casp15_method_interaction_analysis_plotting.ipynb
index 41e425ef..cc6e5664 100644
--- a/notebooks/casp15_method_interaction_analysis_plotting.ipynb
+++ b/notebooks/casp15_method_interaction_analysis_plotting.ipynb
@@ -84,6 +84,8 @@
" \"rfaa\",\n",
" \"chai-lab_ss\",\n",
" \"chai-lab\",\n",
+ " \"boltz_ss\",\n",
+ " \"boltz\",\n",
" \"alphafold3_ss\",\n",
" \"alphafold3\",\n",
"]\n",
@@ -99,7 +101,7 @@
")\n",
"assert os.path.exists(\n",
" casp15_set_dir\n",
- "), \"Please download the (public) CASP15 set from `https://zenodo.org/records/14629652` before proceeding.\"\n",
+ "), \"Please download the (public) CASP15 set from `https://zenodo.org/records/16791095` before proceeding.\"\n",
"\n",
"# Mappings\n",
"method_mapping = {\n",
@@ -110,6 +112,8 @@
" \"rfaa\": \"RFAA\",\n",
" \"chai-lab_ss\": \"Chai-1-Single-Seq\",\n",
" \"chai-lab\": \"Chai-1\",\n",
+ " \"boltz_ss\": \"Boltz-1-Single-Seq\",\n",
+ " \"boltz\": \"Boltz-1\",\n",
" \"alphafold3_ss\": \"AF3-Single-Seq\",\n",
" \"alphafold3\": \"AF3\",\n",
"}\n",
diff --git a/notebooks/casp15_method_interaction_analysis_plotting.py b/notebooks/casp15_method_interaction_analysis_plotting.py
index 7edea537..787fc5fd 100644
--- a/notebooks/casp15_method_interaction_analysis_plotting.py
+++ b/notebooks/casp15_method_interaction_analysis_plotting.py
@@ -49,6 +49,8 @@
"rfaa",
"chai-lab_ss",
"chai-lab",
+ "boltz_ss",
+ "boltz",
"alphafold3_ss",
"alphafold3",
]
@@ -64,7 +66,7 @@
)
assert os.path.exists(
casp15_set_dir
-), "Please download the (public) CASP15 set from `https://zenodo.org/records/14629652` before proceeding."
+), "Please download the (public) CASP15 set from `https://zenodo.org/records/16791095` before proceeding."
# Mappings
method_mapping = {
@@ -75,6 +77,8 @@
"rfaa": "RFAA",
"chai-lab_ss": "Chai-1-Single-Seq",
"chai-lab": "Chai-1",
+ "boltz_ss": "Boltz-1-Single-Seq",
+ "boltz": "Boltz-1",
"alphafold3_ss": "AF3-Single-Seq",
"alphafold3": "AF3",
}
diff --git a/notebooks/casp15_plif_emd_values.png b/notebooks/casp15_plif_emd_values.png
new file mode 100644
index 00000000..29585b23
Binary files /dev/null and b/notebooks/casp15_plif_emd_values.png differ
diff --git a/notebooks/casp15_plif_metrics.csv b/notebooks/casp15_plif_metrics.csv
new file mode 100644
index 00000000..7a213ff2
--- /dev/null
+++ b/notebooks/casp15_plif_metrics.csv
@@ -0,0 +1,188 @@
+,Category,Target,EMD,WM,Method_Histogram,Reference_Histogram
+0,P2Rank-Vina,H1171v2,,0.0,,
+1,P2Rank-Vina,T1158v2,0.4285714285714285,0.9947443860487338,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+2,P2Rank-Vina,T1152,1178.034482758621,0.0,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+3,P2Rank-Vina,T1158v1,0.36842105263157904,0.9959514170040485,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2}"
+4,P2Rank-Vina,H1171v1,,0.0,,
+5,P2Rank-Vina,H1172v1,14.142857142857144,0.7195413282369804,"{'UNL:ALA:Hydrophobic': 9, 'UNL:ALA:VdWContact': 18, 'UNL:ARG:HBAcceptor': 36, 'UNL:ARG:HBDonor': 9, 'UNL:ARG:VdWContact': 63, 'UNL:ASN:HBAcceptor': 9, 'UNL:ASN:HBDonor': 9, 'UNL:ASN:VdWContact': 18, 'UNL:ASP:HBAcceptor': 9, 'UNL:ASP:VdWContact': 9, 'UNL:GLN:HBAcceptor': 18, 'UNL:GLN:HBDonor': 9, 'UNL:GLN:VdWContact': 27, 'UNL:GLU:Hydrophobic': 18, 'UNL:GLU:VdWContact': 63, 'UNL:GLY:HBAcceptor': 36, 'UNL:GLY:VdWContact': 45, 'UNL:ILE:HBAcceptor': 9, 'UNL:ILE:HBDonor': 18, 'UNL:ILE:Hydrophobic': 27, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 9, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 54, 'UNL:PRO:VdWContact': 9, 'UNL:SER:VdWContact': 45, 'UNL:THR:HBAcceptor': 36, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 54, 'UNL:TYR:HBDonor': 9, 'UNL:TYR:Hydrophobic': 36, 'UNL:TYR:VdWContact': 54, 'UNL:VAL:VdWContact': 18}","{'UNL:ARG:HBAcceptor': 54, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 63, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 144, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:VdWContact': 9}"
+6,P2Rank-Vina,T1158v4,4.484848484848484,0.9133475220431743,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:Hydrophobic': 4, 'UNL:ARG:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 4, 'UNL:GLN:HBDonor': 4, 'UNL:GLN:VdWContact': 8, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 12, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 4, 'UNL:SER:VdWContact': 8, 'UNL:THR:HBAcceptor': 4, 'UNL:THR:Hydrophobic': 4, 'UNL:THR:VdWContact': 8, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:HBAcceptor': 4, 'UNL:TYR:VdWContact': 12, 'UNL:VAL:VdWContact': 4}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+7,P2Rank-Vina,H1172v4,,0.0,,
+8,P2Rank-Vina,T1146,0.7142857142857142,0.989010989010989,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+9,P2Rank-Vina,H1172v2,,0.0,,
+10,P2Rank-Vina,T1186,0.9999999999999999,0.9832775919732442,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+11,P2Rank-Vina,T1187,1.1428571428571426,0.9804108934543717,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 8, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 4, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 4}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+12,P2Rank-Vina,T1127v2,5.0,0.9030100334448161,"{'UNL:ALA:Hydrophobic': 5, 'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 10, 'UNL:ARG:HBDonor': 10, 'UNL:ARG:VdWContact': 30, 'UNL:ASN:HBAcceptor': 15, 'UNL:ASN:Hydrophobic': 5, 'UNL:ASN:VdWContact': 15, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:HBAcceptor': 5, 'UNL:GLN:VdWContact': 5, 'UNL:GLU:HBDonor': 10, 'UNL:GLU:Hydrophobic': 15, 'UNL:GLU:VdWContact': 35, 'UNL:GLY:HBDonor': 5, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:VdWContact': 5, 'UNL:ILE:HBAcceptor': 10, 'UNL:ILE:Hydrophobic': 15, 'UNL:ILE:VdWContact': 25, 'UNL:LEU:Hydrophobic': 30, 'UNL:LEU:VdWContact': 35, 'UNL:MET:HBAcceptor': 5, 'UNL:MET:Hydrophobic': 10, 'UNL:MET:VdWContact': 10, 'UNL:PHE:Hydrophobic': 35, 'UNL:PHE:VdWContact': 40, 'UNL:PRO:Hydrophobic': 5, 'UNL:PRO:VdWContact': 5, 'UNL:TRP:Hydrophobic': 10, 'UNL:TRP:VdWContact': 15, 'UNL:TYR:HBAcceptor': 10, 'UNL:TYR:Hydrophobic': 15, 'UNL:TYR:VdWContact': 15, 'UNL:VAL:VdWContact': 10}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+13,P2Rank-Vina,T1124,2.0000000000000004,0.9632107023411371,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:HBDonor': 4, 'UNL:ASN:Hydrophobic': 4, 'UNL:ASN:VdWContact': 12, 'UNL:ASP:HBDonor': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:Hydrophobic': 4, 'UNL:GLN:VdWContact': 8, 'UNL:GLU:Hydrophobic': 4, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 12, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:ILE:VdWContact': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:PRO:Hydrophobic': 4, 'UNL:PRO:VdWContact': 4, 'UNL:SER:VdWContact': 8, 'UNL:THR:Hydrophobic': 8, 'UNL:THR:VdWContact': 8, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 8, 'UNL:TYR:HBAcceptor': 4, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 8, 'UNL:VAL:HBDonor': 4, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 8}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+14,P2Rank-Vina,T1158v3,0.4615384615384614,0.9940828402366864,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+15,P2Rank-Vina,H1172v3,,0.0,,
+16,P2Rank-Vina,H1135,48.0,0.04013377926421402,"{'UNL:ALA:VdWContact': 12, 'UNL:ARG:VdWContact': 48, 'UNL:ASN:VdWContact': 24, 'UNL:ASP:VdWContact': 48, 'UNL:GLN:VdWContact': 60, 'UNL:GLY:VdWContact': 24, 'UNL:HIS:VdWContact': 12, 'UNL:ILE:VdWContact': 36, 'UNL:LEU:VdWContact': 24, 'UNL:PHE:VdWContact': 12, 'UNL:SER:VdWContact': 36, 'UNL:THR:VdWContact': 24, 'UNL:TRP:VdWContact': 24, 'UNL:TYR:VdWContact': 48, 'UNL:VAL:VdWContact': 48}","{'UNL:ARG:VdWContact': 72, 'UNL:ASN:VdWContact': 144, 'UNL:ASP:VdWContact': 144, 'UNL:GLN:VdWContact': 144, 'UNL:ILE:VdWContact': 108, 'UNL:SER:VdWContact': 36, 'UNL:TYR:VdWContact': 144, 'UNL:VAL:VdWContact': 144}"
+17,DiffDock-L,H1171v2,,0.0,,
+18,DiffDock-L,T1158v2,0.23076923076923067,0.9987136609210188,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+19,DiffDock-L,T1152,1138.4999999999998,0.0,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+20,DiffDock-L,T1158v1,0.3846153846153845,0.9956264471314639,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2}"
+21,DiffDock-L,H1171v1,,0.0,,
+22,DiffDock-L,H1172v1,12.789473684210527,0.7466995247315613,"{'UNL:ALA:VdWContact': 9, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 54, 'UNL:GLY:VdWContact': 54, 'UNL:ILE:HBDonor': 27, 'UNL:ILE:Hydrophobic': 27, 'UNL:ILE:VdWContact': 27, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:VdWContact': 27, 'UNL:PRO:Hydrophobic': 99, 'UNL:PRO:VdWContact': 36, 'UNL:THR:HBAcceptor': 27, 'UNL:THR:VdWContact': 54, 'UNL:TYR:HBDonor': 18, 'UNL:TYR:Hydrophobic': 54, 'UNL:TYR:VdWContact': 54}","{'UNL:ARG:HBAcceptor': 54, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 63, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 144, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:VdWContact': 9}"
+23,DiffDock-L,T1158v4,6.476190476190476,0.8733874820831342,"{'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 4, 'UNL:GLN:VdWContact': 4, 'UNL:GLY:HBAcceptor': 4, 'UNL:GLY:HBDonor': 4, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 4, 'UNL:LYS:VdWContact': 4, 'UNL:SER:HBAcceptor': 4, 'UNL:SER:HBDonor': 4, 'UNL:SER:VdWContact': 8, 'UNL:THR:VdWContact': 4, 'UNL:TYR:HBAcceptor': 4, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:VdWContact': 4}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+24,DiffDock-L,H1172v4,,0.0,,
+25,DiffDock-L,T1146,0.4545454545454546,0.9942231681362116,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+26,DiffDock-L,H1172v2,,0.0,,
+27,DiffDock-L,T1186,0.4615384615384615,0.9940828402366864,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+28,DiffDock-L,T1187,1.368421052631579,0.9758845273719415,"{'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 4}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+29,DiffDock-L,T1127v2,2.5000000000000004,0.9531772575250836,"{'UNL:ALA:Hydrophobic': 5, 'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 10, 'UNL:ARG:Hydrophobic': 5, 'UNL:ARG:VdWContact': 20, 'UNL:GLN:HBAcceptor': 5, 'UNL:GLN:Hydrophobic': 5, 'UNL:GLN:VdWContact': 5, 'UNL:GLU:VdWContact': 15, 'UNL:GLY:HBAcceptor': 10, 'UNL:GLY:HBDonor': 5, 'UNL:GLY:VdWContact': 10, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:Hydrophobic': 15, 'UNL:ILE:VdWContact': 15, 'UNL:LEU:Hydrophobic': 10, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:VdWContact': 5, 'UNL:MET:Hydrophobic': 15, 'UNL:MET:VdWContact': 15, 'UNL:PHE:HBDonor': 5, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:Hydrophobic': 10, 'UNL:TRP:VdWContact': 10, 'UNL:TYR:VdWContact': 5}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+30,DiffDock-L,T1124,2.133333333333333,0.9605351170568562,"{'UNL:ALA:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:Hydrophobic': 4, 'UNL:ASN:VdWContact': 4, 'UNL:ASP:HBDonor': 8, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 8, 'UNL:CYS:VdWContact': 4, 'UNL:GLY:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:ILE:VdWContact': 12, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 4, 'UNL:PHE:HBAcceptor': 4, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:PRO:Hydrophobic': 4, 'UNL:PRO:VdWContact': 4, 'UNL:SER:HBAcceptor': 4, 'UNL:SER:HBDonor': 4, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 12, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 12, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+31,DiffDock-L,T1158v3,0.33333333333333326,0.9966555183946488,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+32,DiffDock-L,H1172v3,,0.0,,
+33,DiffDock-L,H1135,55.2,0.0,"{'UNL:ARG:VdWContact': 12, 'UNL:GLN:VdWContact': 12, 'UNL:GLU:VdWContact': 24, 'UNL:LEU:VdWContact': 12, 'UNL:LYS:VdWContact': 12, 'UNL:MET:VdWContact': 12, 'UNL:PHE:VdWContact': 12, 'UNL:SER:VdWContact': 12, 'UNL:THR:VdWContact': 24, 'UNL:TRP:VdWContact': 24}","{'UNL:ARG:VdWContact': 72, 'UNL:ASN:VdWContact': 144, 'UNL:ASP:VdWContact': 144, 'UNL:GLN:VdWContact': 144, 'UNL:ILE:VdWContact': 108, 'UNL:SER:VdWContact': 36, 'UNL:TYR:VdWContact': 144, 'UNL:VAL:VdWContact': 144}"
+34,DynamicBind,H1171v2,20.57142857142857,0.5905398948877211,"{'UNL:ALA:VdWContact': 9, 'UNL:ARG:HBAcceptor': 9, 'UNL:ARG:Hydrophobic': 18, 'UNL:ARG:VdWContact': 45, 'UNL:ASP:Hydrophobic': 9, 'UNL:ASP:VdWContact': 9, 'UNL:GLU:HBAcceptor': 9, 'UNL:GLU:HBDonor': 9, 'UNL:GLU:Hydrophobic': 9, 'UNL:GLU:VdWContact': 27, 'UNL:GLY:HBAcceptor': 36, 'UNL:GLY:HBDonor': 9, 'UNL:GLY:VdWContact': 36, 'UNL:ILE:Hydrophobic': 18, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:HBDonor': 9, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:VdWContact': 18, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 18, 'UNL:THR:HBAcceptor': 27, 'UNL:THR:VdWContact': 36, 'UNL:TYR:HBDonor': 9, 'UNL:TYR:Hydrophobic': 18, 'UNL:TYR:VdWContact': 18}","{'UNL:ARG:HBAcceptor': 72, 'UNL:ARG:VdWContact': 81, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 36, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 63, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 162}"
+35,DynamicBind,T1158v2,0.25,0.9983277591973244,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+36,DynamicBind,T1152,1138.7,0.0,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+37,DynamicBind,T1158v1,0.2666666666666667,0.9979933110367893,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2}"
+38,DynamicBind,H1171v1,29.480000000000004,0.4117725752508361,"{'UNL:ALA:VdWContact': 11, 'UNL:ARG:HBAcceptor': 22, 'UNL:ARG:Hydrophobic': 22, 'UNL:ARG:VdWContact': 44, 'UNL:ASP:Hydrophobic': 11, 'UNL:ASP:VdWContact': 11, 'UNL:GLU:HBDonor': 11, 'UNL:GLU:Hydrophobic': 11, 'UNL:GLU:VdWContact': 33, 'UNL:GLY:HBAcceptor': 55, 'UNL:GLY:HBDonor': 11, 'UNL:GLY:VdWContact': 55, 'UNL:ILE:Hydrophobic': 22, 'UNL:LEU:HBDonor': 22, 'UNL:LEU:VdWContact': 22, 'UNL:LYS:VdWContact': 22, 'UNL:PRO:Hydrophobic': 22, 'UNL:PRO:VdWContact': 22, 'UNL:THR:HBAcceptor': 22, 'UNL:THR:VdWContact': 33, 'UNL:TYR:Hydrophobic': 44, 'UNL:TYR:VdWContact': 22}","{'UNL:ARG:HBAcceptor': 110, 'UNL:ARG:VdWContact': 99, 'UNL:ASN:VdWContact': 11, 'UNL:ASP:VdWContact': 22, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 121, 'UNL:ILE:VdWContact': 55, 'UNL:LEU:VdWContact': 11, 'UNL:LYS:HBAcceptor': 44, 'UNL:LYS:VdWContact': 44, 'UNL:PRO:Hydrophobic': 44, 'UNL:PRO:VdWContact': 55, 'UNL:THR:HBAcceptor': 88, 'UNL:THR:VdWContact': 231, 'UNL:TYR:VdWContact': 11}"
+39,DynamicBind,H1172v1,18.0,0.6421404682274248,"{'UNL:ARG:HBAcceptor': 18, 'UNL:ARG:VdWContact': 36, 'UNL:ASP:VdWContact': 9, 'UNL:GLU:Hydrophobic': 9, 'UNL:GLU:VdWContact': 18, 'UNL:GLY:HBAcceptor': 36, 'UNL:GLY:HBDonor': 9, 'UNL:GLY:VdWContact': 36, 'UNL:ILE:HBDonor': 9, 'UNL:ILE:Hydrophobic': 18, 'UNL:ILE:VdWContact': 9, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:HBDonor': 9, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 9, 'UNL:LYS:VdWContact': 18, 'UNL:PRO:Hydrophobic': 36, 'UNL:PRO:VdWContact': 27, 'UNL:THR:HBAcceptor': 18, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 45, 'UNL:TYR:HBDonor': 9, 'UNL:TYR:Hydrophobic': 27, 'UNL:TYR:VdWContact': 36}","{'UNL:ARG:HBAcceptor': 54, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 63, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 144, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:VdWContact': 9}"
+40,DynamicBind,T1158v4,4.545454545454545,0.9121313469139556,"{'UNL:ALA:VdWContact': 4, 'UNL:ARG:VdWContact': 12, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:HBAcceptor': 8, 'UNL:GLY:HBDonor': 4, 'UNL:GLY:VdWContact': 12, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 4, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:VdWContact': 4, 'UNL:SER:VdWContact': 8, 'UNL:THR:VdWContact': 4, 'UNL:TRP:VdWContact': 4, 'UNL:VAL:HBDonor': 4, 'UNL:VAL:VdWContact': 8}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+41,DynamicBind,H1172v4,14.225806451612902,0.717876793613119,"{'UNL:ALA:Hydrophobic': 9, 'UNL:ARG:HBAcceptor': 9, 'UNL:ARG:HBDonor': 9, 'UNL:ARG:Hydrophobic': 18, 'UNL:ARG:VdWContact': 54, 'UNL:ASN:Hydrophobic': 9, 'UNL:ASN:VdWContact': 9, 'UNL:ASP:Hydrophobic': 9, 'UNL:ASP:VdWContact': 9, 'UNL:GLU:HBAcceptor': 9, 'UNL:GLU:HBDonor': 9, 'UNL:GLU:Hydrophobic': 9, 'UNL:GLU:VdWContact': 18, 'UNL:GLY:HBAcceptor': 36, 'UNL:GLY:VdWContact': 36, 'UNL:ILE:HBDonor': 9, 'UNL:ILE:Hydrophobic': 18, 'UNL:ILE:VdWContact': 9, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:VdWContact': 27, 'UNL:PRO:Hydrophobic': 36, 'UNL:PRO:VdWContact': 18, 'UNL:SER:VdWContact': 9, 'UNL:THR:HBAcceptor': 54, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 63, 'UNL:TYR:HBDonor': 9, 'UNL:TYR:Hydrophobic': 36, 'UNL:TYR:VdWContact': 36}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 36, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+42,DynamicBind,T1146,0.19999999999999996,0.9993311036789297,"{'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+43,DynamicBind,H1172v2,19.173913043478258,0.6185836847462558,"{'UNL:ARG:HBAcceptor': 18, 'UNL:ARG:Hydrophobic': 18, 'UNL:ARG:VdWContact': 63, 'UNL:ASP:VdWContact': 18, 'UNL:GLU:VdWContact': 18, 'UNL:GLY:HBAcceptor': 18, 'UNL:GLY:VdWContact': 36, 'UNL:ILE:HBDonor': 9, 'UNL:ILE:Hydrophobic': 9, 'UNL:ILE:VdWContact': 18, 'UNL:LEU:HBDonor': 9, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:VdWContact': 18, 'UNL:PHE:VdWContact': 9, 'UNL:PRO:Hydrophobic': 36, 'UNL:PRO:VdWContact': 27, 'UNL:THR:HBAcceptor': 27, 'UNL:THR:Hydrophobic': 18, 'UNL:THR:VdWContact': 54, 'UNL:TYR:HBDonor': 9, 'UNL:TYR:Hydrophobic': 18, 'UNL:TYR:VdWContact': 18}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:VdWContact': 9, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 27, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+44,DynamicBind,T1186,0.4285714285714285,0.9947443860487338,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+45,DynamicBind,T1187,1.5294117647058825,0.9726539445209522,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 4, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+46,DynamicBind,T1127v2,2.027027027027027,0.9626683539727018,"{'UNL:ARG:HBAcceptor': 5, 'UNL:ARG:HBDonor': 5, 'UNL:ARG:Hydrophobic': 5, 'UNL:ARG:VdWContact': 15, 'UNL:ASP:Hydrophobic': 5, 'UNL:ASP:VdWContact': 5, 'UNL:GLU:HBDonor': 10, 'UNL:GLU:Hydrophobic': 20, 'UNL:GLU:VdWContact': 20, 'UNL:ILE:Hydrophobic': 10, 'UNL:ILE:VdWContact': 15, 'UNL:LEU:Hydrophobic': 15, 'UNL:LEU:VdWContact': 25, 'UNL:MET:Hydrophobic': 5, 'UNL:MET:VdWContact': 5, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 5, 'UNL:SER:VdWContact': 5, 'UNL:TRP:HBAcceptor': 5, 'UNL:TRP:Hydrophobic': 10, 'UNL:TRP:VdWContact': 15, 'UNL:TYR:HBAcceptor': 5, 'UNL:TYR:Hydrophobic': 10, 'UNL:TYR:VdWContact': 10}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+47,DynamicBind,T1124,,0.0,,
+48,DynamicBind,T1158v3,0.3333333333333334,0.9966555183946488,"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+49,DynamicBind,H1172v3,13.538461538461537,0.7316696681245176,"{'UNL:ARG:HBAcceptor': 8, 'UNL:ARG:Hydrophobic': 16, 'UNL:ARG:VdWContact': 40, 'UNL:ASP:VdWContact': 16, 'UNL:GLU:Hydrophobic': 8, 'UNL:GLU:VdWContact': 24, 'UNL:GLY:HBAcceptor': 32, 'UNL:GLY:HBDonor': 8, 'UNL:GLY:VdWContact': 40, 'UNL:ILE:HBDonor': 8, 'UNL:ILE:Hydrophobic': 16, 'UNL:ILE:VdWContact': 8, 'UNL:LEU:HBDonor': 8, 'UNL:LEU:VdWContact': 24, 'UNL:LYS:HBAcceptor': 16, 'UNL:LYS:HBDonor': 8, 'UNL:LYS:Hydrophobic': 8, 'UNL:LYS:VdWContact': 16, 'UNL:PRO:Hydrophobic': 56, 'UNL:PRO:VdWContact': 48, 'UNL:THR:HBAcceptor': 24, 'UNL:THR:Hydrophobic': 24, 'UNL:THR:VdWContact': 40, 'UNL:TYR:HBDonor': 16, 'UNL:TYR:Hydrophobic': 32, 'UNL:TYR:VdWContact': 24}","{'UNL:ARG:HBAcceptor': 56, 'UNL:ARG:VdWContact': 64, 'UNL:GLY:HBAcceptor': 64, 'UNL:GLY:VdWContact': 72, 'UNL:ILE:VdWContact': 32, 'UNL:LEU:VdWContact': 24, 'UNL:LYS:HBAcceptor': 40, 'UNL:LYS:VdWContact': 48, 'UNL:PRO:Hydrophobic': 16, 'UNL:PRO:VdWContact': 24, 'UNL:THR:HBAcceptor': 56, 'UNL:THR:VdWContact': 88}"
+50,DynamicBind,H1135,51.69230769230769,0.0,"{'UNL:CYS:VdWContact': 24, 'UNL:GLY:VdWContact': 24, 'UNL:MET:VdWContact': 12, 'UNL:PRO:VdWContact': 60, 'UNL:SER:VdWContact': 60, 'UNL:THR:VdWContact': 36, 'UNL:TYR:VdWContact': 36, 'UNL:VAL:VdWContact': 12}","{'UNL:ARG:VdWContact': 72, 'UNL:ASN:VdWContact': 144, 'UNL:ASP:VdWContact': 144, 'UNL:GLN:VdWContact': 144, 'UNL:ILE:VdWContact': 108, 'UNL:SER:VdWContact': 36, 'UNL:TYR:VdWContact': 144, 'UNL:VAL:VdWContact': 144}"
+51,NeuralPLexer,H1171v2,13.178571428571429,0.7388915432393693,"{'UNL:ALA:Hydrophobic': 18, 'UNL:ALA:VdWContact': 9, 'UNL:ARG:HBDonor': 18, 'UNL:ARG:Hydrophobic': 36, 'UNL:ARG:VdWContact': 117, 'UNL:ASN:HBAcceptor': 27, 'UNL:ASN:HBDonor': 27, 'UNL:ASN:VdWContact': 36, 'UNL:GLU:HBDonor': 18, 'UNL:GLU:VdWContact': 18, 'UNL:GLY:HBAcceptor': 27, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:Hydrophobic': 45, 'UNL:ILE:VdWContact': 36, 'UNL:LEU:Hydrophobic': 18, 'UNL:LEU:VdWContact': 90, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:Hydrophobic': 9, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 63, 'UNL:PRO:VdWContact': 63, 'UNL:THR:HBAcceptor': 9, 'UNL:THR:VdWContact': 81, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:Hydrophobic': 27, 'UNL:TYR:VdWContact': 36}","{'UNL:ARG:HBAcceptor': 72, 'UNL:ARG:VdWContact': 81, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 36, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 63, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 162}"
+52,NeuralPLexer,T1158v2,0.39999999999999997,0.9953177257525083,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+53,NeuralPLexer,T1152,1220.1785714285713,0.0,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+54,NeuralPLexer,T1158v1,0.44444444444444453,0.9944258639910813,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2}"
+55,NeuralPLexer,H1171v1,16.84375,0.6653428093645486,"{'UNL:ALA:Hydrophobic': 11, 'UNL:ARG:HBDonor': 22, 'UNL:ARG:Hydrophobic': 33, 'UNL:ARG:VdWContact': 121, 'UNL:ASN:HBAcceptor': 44, 'UNL:ASN:Hydrophobic': 22, 'UNL:ASN:VdWContact': 55, 'UNL:ASP:VdWContact': 11, 'UNL:GLU:HBDonor': 22, 'UNL:GLU:VdWContact': 22, 'UNL:GLY:VdWContact': 99, 'UNL:ILE:Hydrophobic': 33, 'UNL:ILE:VdWContact': 33, 'UNL:LEU:HBAcceptor': 11, 'UNL:LEU:HBDonor': 11, 'UNL:LEU:Hydrophobic': 11, 'UNL:LEU:VdWContact': 77, 'UNL:LYS:HBAcceptor': 22, 'UNL:LYS:Hydrophobic': 33, 'UNL:LYS:VdWContact': 55, 'UNL:MET:HBAcceptor': 11, 'UNL:MET:VdWContact': 22, 'UNL:PRO:HBDonor': 11, 'UNL:PRO:Hydrophobic': 44, 'UNL:PRO:VdWContact': 44, 'UNL:THR:HBAcceptor': 22, 'UNL:THR:VdWContact': 132, 'UNL:TYR:HBDonor': 11, 'UNL:TYR:Hydrophobic': 44, 'UNL:TYR:VdWContact': 55}","{'UNL:ARG:HBAcceptor': 110, 'UNL:ARG:VdWContact': 99, 'UNL:ASN:VdWContact': 11, 'UNL:ASP:VdWContact': 22, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 121, 'UNL:ILE:VdWContact': 55, 'UNL:LEU:VdWContact': 11, 'UNL:LYS:HBAcceptor': 44, 'UNL:LYS:VdWContact': 44, 'UNL:PRO:Hydrophobic': 44, 'UNL:PRO:VdWContact': 55, 'UNL:THR:HBAcceptor': 88, 'UNL:THR:VdWContact': 231, 'UNL:TYR:VdWContact': 11}"
+56,NeuralPLexer,H1172v1,16.758620689655167,0.6670510898396957,"{'UNL:ALA:Hydrophobic': 9, 'UNL:ALA:VdWContact': 9, 'UNL:ARG:HBDonor': 36, 'UNL:ARG:Hydrophobic': 18, 'UNL:ARG:VdWContact': 99, 'UNL:ASN:HBAcceptor': 18, 'UNL:ASN:HBDonor': 18, 'UNL:ASN:VdWContact': 54, 'UNL:GLU:HBDonor': 18, 'UNL:GLU:VdWContact': 18, 'UNL:GLY:HBAcceptor': 36, 'UNL:GLY:VdWContact': 99, 'UNL:ILE:Hydrophobic': 63, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:VdWContact': 99, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:Hydrophobic': 18, 'UNL:LYS:VdWContact': 54, 'UNL:MET:HBAcceptor': 9, 'UNL:PRO:HBDonor': 9, 'UNL:PRO:Hydrophobic': 81, 'UNL:PRO:VdWContact': 81, 'UNL:THR:HBAcceptor': 18, 'UNL:THR:VdWContact': 81, 'UNL:TYR:Hydrophobic': 45, 'UNL:TYR:VdWContact': 27}","{'UNL:ARG:HBAcceptor': 54, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 63, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 144, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:VdWContact': 9}"
+57,NeuralPLexer,T1158v4,4.190476190476191,0.9192546583850931,"{'UNL:ASP:HBDonor': 4, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBAcceptor': 12, 'UNL:GLY:VdWContact': 16, 'UNL:LYS:HBAcceptor': 4, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 8, 'UNL:SER:VdWContact': 16, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:HBAcceptor': 4, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:VdWContact': 8}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+58,NeuralPLexer,H1172v4,10.741935483870968,0.7877872478152983,"{'UNL:ALA:Hydrophobic': 9, 'UNL:ALA:VdWContact': 9, 'UNL:ARG:HBDonor': 27, 'UNL:ARG:Hydrophobic': 18, 'UNL:ARG:VdWContact': 126, 'UNL:ASN:HBAcceptor': 27, 'UNL:ASN:HBDonor': 9, 'UNL:ASN:VdWContact': 27, 'UNL:ASP:VdWContact': 9, 'UNL:GLU:HBDonor': 27, 'UNL:GLU:VdWContact': 27, 'UNL:GLY:HBAcceptor': 9, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:Hydrophobic': 27, 'UNL:ILE:VdWContact': 9, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:HBDonor': 9, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 81, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:HBDonor': 9, 'UNL:LYS:Hydrophobic': 18, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:HBDonor': 18, 'UNL:PRO:Hydrophobic': 54, 'UNL:PRO:VdWContact': 90, 'UNL:THR:HBAcceptor': 18, 'UNL:THR:VdWContact': 90, 'UNL:TYR:Hydrophobic': 45, 'UNL:TYR:VdWContact': 27}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 36, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+59,NeuralPLexer,T1146,0.36363636363636365,0.9960474308300395,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+60,NeuralPLexer,H1172v2,14.0625,0.7211538461538461,"{'UNL:ALA:Hydrophobic': 9, 'UNL:ALA:VdWContact': 9, 'UNL:ARG:HBDonor': 27, 'UNL:ARG:Hydrophobic': 27, 'UNL:ARG:VdWContact': 90, 'UNL:ASN:HBAcceptor': 54, 'UNL:ASN:HBDonor': 27, 'UNL:ASN:VdWContact': 63, 'UNL:ASP:VdWContact': 9, 'UNL:GLU:HBDonor': 27, 'UNL:GLU:VdWContact': 27, 'UNL:GLY:HBAcceptor': 9, 'UNL:GLY:HBDonor': 9, 'UNL:GLY:VdWContact': 99, 'UNL:ILE:Hydrophobic': 45, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 54, 'UNL:LYS:HBAcceptor': 9, 'UNL:LYS:Hydrophobic': 9, 'UNL:LYS:VdWContact': 54, 'UNL:MET:HBAcceptor': 9, 'UNL:MET:Hydrophobic': 9, 'UNL:MET:VdWContact': 18, 'UNL:PRO:HBDonor': 9, 'UNL:PRO:Hydrophobic': 63, 'UNL:PRO:VdWContact': 81, 'UNL:THR:HBAcceptor': 9, 'UNL:THR:VdWContact': 117, 'UNL:TYR:Hydrophobic': 36, 'UNL:TYR:VdWContact': 27}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:VdWContact': 9, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 27, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+61,NeuralPLexer,T1186,0.5,0.9933110367892977,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+62,NeuralPLexer,T1187,1.25,0.9782608695652174,"{'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 10, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+63,NeuralPLexer,T1127v2,1.71875,0.9688545150501672,"{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 20, 'UNL:ARG:HBDonor': 5, 'UNL:ARG:Hydrophobic': 10, 'UNL:ARG:VdWContact': 25, 'UNL:ASN:HBDonor': 5, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 15, 'UNL:GLN:VdWContact': 15, 'UNL:GLU:VdWContact': 25, 'UNL:GLY:HBAcceptor': 10, 'UNL:GLY:HBDonor': 5, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:HBDonor': 5, 'UNL:LYS:VdWContact': 10, 'UNL:MET:Hydrophobic': 10, 'UNL:MET:VdWContact': 10, 'UNL:PHE:Hydrophobic': 30, 'UNL:PHE:VdWContact': 40, 'UNL:TRP:Hydrophobic': 10, 'UNL:TRP:VdWContact': 10, 'UNL:TYR:VdWContact': 10, 'UNL:VAL:VdWContact': 5}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+64,NeuralPLexer,T1124,2.580645161290323,0.9515589599741072,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASN:Hydrophobic': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:HBDonor': 4, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 16, 'UNL:CYS:VdWContact': 8, 'UNL:GLN:VdWContact': 4, 'UNL:GLY:VdWContact': 12, 'UNL:HIS:VdWContact': 4, 'UNL:ILE:Hydrophobic': 8, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 12, 'UNL:PHE:HBAcceptor': 4, 'UNL:PHE:Hydrophobic': 16, 'UNL:PHE:VdWContact': 24, 'UNL:PRO:Hydrophobic': 4, 'UNL:PRO:VdWContact': 4, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 16, 'UNL:TYR:HBAcceptor': 4, 'UNL:TYR:VdWContact': 24, 'UNL:VAL:Hydrophobic': 8}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+65,NeuralPLexer,T1158v3,0.33333333333333326,0.9966555183946488,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+66,NeuralPLexer,H1172v3,11.84,0.765752508361204,"{'UNL:ARG:HBAcceptor': 8, 'UNL:ARG:HBDonor': 8, 'UNL:ARG:VdWContact': 88, 'UNL:ASN:HBAcceptor': 16, 'UNL:ASN:HBDonor': 8, 'UNL:ASN:VdWContact': 40, 'UNL:GLU:HBDonor': 16, 'UNL:GLU:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 88, 'UNL:ILE:Hydrophobic': 48, 'UNL:ILE:VdWContact': 32, 'UNL:LEU:HBDonor': 8, 'UNL:LEU:VdWContact': 64, 'UNL:LYS:HBAcceptor': 16, 'UNL:LYS:Hydrophobic': 8, 'UNL:LYS:VdWContact': 32, 'UNL:PRO:HBDonor': 16, 'UNL:PRO:Hydrophobic': 64, 'UNL:PRO:VdWContact': 80, 'UNL:THR:HBAcceptor': 24, 'UNL:THR:HBDonor': 8, 'UNL:THR:VdWContact': 72, 'UNL:TYR:Hydrophobic': 48, 'UNL:TYR:VdWContact': 40}","{'UNL:ARG:HBAcceptor': 56, 'UNL:ARG:VdWContact': 64, 'UNL:GLY:HBAcceptor': 64, 'UNL:GLY:VdWContact': 72, 'UNL:ILE:VdWContact': 32, 'UNL:LEU:VdWContact': 24, 'UNL:LYS:HBAcceptor': 40, 'UNL:LYS:VdWContact': 48, 'UNL:PRO:Hydrophobic': 16, 'UNL:PRO:VdWContact': 24, 'UNL:THR:HBAcceptor': 56, 'UNL:THR:VdWContact': 88}"
+67,NeuralPLexer,H1135,43.71428571428571,0.12613473483038717,"{'UNL:ARG:VdWContact': 12, 'UNL:ASN:VdWContact': 60, 'UNL:ASP:VdWContact': 60, 'UNL:GLN:VdWContact': 24, 'UNL:GLU:VdWContact': 24, 'UNL:GLY:VdWContact': 36, 'UNL:HIS:VdWContact': 12, 'UNL:ILE:VdWContact': 12, 'UNL:LEU:VdWContact': 48, 'UNL:PRO:VdWContact': 60, 'UNL:SER:VdWContact': 72, 'UNL:TRP:VdWContact': 12, 'UNL:TYR:VdWContact': 48, 'UNL:VAL:VdWContact': 12}","{'UNL:ARG:VdWContact': 72, 'UNL:ASN:VdWContact': 144, 'UNL:ASP:VdWContact': 144, 'UNL:GLN:VdWContact': 144, 'UNL:ILE:VdWContact': 108, 'UNL:SER:VdWContact': 36, 'UNL:TYR:VdWContact': 144, 'UNL:VAL:VdWContact': 144}"
+68,RFAA,H1171v2,,0.0,,
+69,RFAA,T1158v2,0.5,0.9933110367892977,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+70,RFAA,T1152,1366.52,0.0,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+71,RFAA,T1158v1,,0.0,,
+72,RFAA,H1171v1,,0.0,,
+73,RFAA,H1172v1,,0.0,,
+74,RFAA,T1158v4,,0.0,,
+75,RFAA,H1172v4,,0.0,,
+76,RFAA,T1146,0.5833333333333333,0.9916387959866221,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+77,RFAA,H1172v2,,0.0,,
+78,RFAA,T1186,,0.0,,
+79,RFAA,T1187,1.3333333333333333,0.9765886287625418,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 6, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:HBDonor': 2, 'UNL:TRP:Hydrophobic': 6, 'UNL:TRP:VdWContact': 10, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+80,RFAA,T1127v2,2.1794871794871793,0.9596089529199897,"{'UNL:ALA:HBAcceptor': 5, 'UNL:ALA:HBDonor': 5, 'UNL:ALA:VdWContact': 10, 'UNL:ARG:HBDonor': 5, 'UNL:ARG:VdWContact': 20, 'UNL:ASN:VdWContact': 15, 'UNL:CYS:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:HBDonor': 10, 'UNL:GLU:VdWContact': 30, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:VdWContact': 5, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:HBDonor': 5, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 20, 'UNL:LEU:Hydrophobic': 10, 'UNL:LEU:VdWContact': 20, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 10, 'UNL:PHE:HBDonor': 5, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 25, 'UNL:THR:HBDonor': 5, 'UNL:THR:VdWContact': 5, 'UNL:TRP:Hydrophobic': 10, 'UNL:TRP:VdWContact': 15, 'UNL:TYR:HBDonor': 5, 'UNL:TYR:Hydrophobic': 15, 'UNL:TYR:VdWContact': 15, 'UNL:VAL:VdWContact': 10}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+81,RFAA,T1124,,0.0,,
+82,RFAA,T1158v3,,0.0,,
+83,RFAA,H1172v3,,0.0,,
+84,RFAA,H1135,,0.0,,
+85,Chai-1-Single-Seq,H1171v2,,0.0,,
+86,Chai-1-Single-Seq,T1158v2,,0.0,,
+87,Chai-1-Single-Seq,T1152,1101.4516129032259,0.0,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 5, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+88,Chai-1-Single-Seq,T1158v1,,0.0,,
+89,Chai-1-Single-Seq,H1171v1,,0.0,,
+90,Chai-1-Single-Seq,H1172v1,,0.0,,
+91,Chai-1-Single-Seq,T1158v4,3.259259259259259,0.9379412857673727,"{'UNL:ALA:HBDonor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASN:HBDonor': 4, 'UNL:ASN:VdWContact': 4, 'UNL:ASP:HBDonor': 4, 'UNL:ASP:VdWContact': 12, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:HBDonor': 4, 'UNL:GLN:VdWContact': 12, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:HBDonor': 4, 'UNL:GLY:VdWContact': 24, 'UNL:HIS:HBDonor': 4, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:HBDonor': 4, 'UNL:SER:VdWContact': 28, 'UNL:THR:VdWContact': 12, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:VdWContact': 12}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+92,Chai-1-Single-Seq,H1172v4,,0.0,,
+93,Chai-1-Single-Seq,T1146,0.9375,0.9845317725752508,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+94,Chai-1-Single-Seq,H1172v2,,0.0,,
+95,Chai-1-Single-Seq,T1186,0.689655172413793,0.9895052473763118,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+96,Chai-1-Single-Seq,T1187,1.391304347826087,0.9754253308128544,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 4, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+97,Chai-1-Single-Seq,T1127v2,3.5555555555555554,0.9319955406911928,"{'UNL:ALA:HBAcceptor': 5, 'UNL:ALA:Hydrophobic': 10, 'UNL:ALA:VdWContact': 20, 'UNL:ARG:HBAcceptor': 5, 'UNL:ARG:VdWContact': 10, 'UNL:ASN:HBAcceptor': 5, 'UNL:ASN:Hydrophobic': 5, 'UNL:ASN:VdWContact': 5, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:HBAcceptor': 5, 'UNL:GLN:HBDonor': 5, 'UNL:GLN:Hydrophobic': 5, 'UNL:GLN:VdWContact': 15, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 5, 'UNL:GLY:VdWContact': 10, 'UNL:ILE:HBDonor': 5, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 15, 'UNL:LEU:HBAcceptor': 5, 'UNL:LEU:HBDonor': 5, 'UNL:LEU:Hydrophobic': 25, 'UNL:LEU:VdWContact': 40, 'UNL:LYS:HBDonor': 5, 'UNL:LYS:VdWContact': 5, 'UNL:MET:Hydrophobic': 5, 'UNL:PHE:HBAcceptor': 5, 'UNL:PHE:Hydrophobic': 35, 'UNL:PHE:VdWContact': 50, 'UNL:PRO:Hydrophobic': 5, 'UNL:PRO:VdWContact': 15, 'UNL:SER:VdWContact': 15, 'UNL:THR:HBDonor': 10, 'UNL:THR:Hydrophobic': 5, 'UNL:THR:VdWContact': 15, 'UNL:TYR:Hydrophobic': 5, 'UNL:TYR:VdWContact': 10, 'UNL:VAL:Hydrophobic': 20, 'UNL:VAL:VdWContact': 25}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+98,Chai-1-Single-Seq,T1124,3.172413793103448,0.9396840041517702,"{'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:VdWContact': 4, 'UNL:HIS:VdWContact': 4, 'UNL:ILE:HBAcceptor': 4, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:VdWContact': 4, 'UNL:PRO:Hydrophobic': 4, 'UNL:PRO:VdWContact': 4, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBDonor': 8, 'UNL:THR:Hydrophobic': 4, 'UNL:THR:VdWContact': 12, 'UNL:TYR:HBDonor': 4, 'UNL:TYR:VdWContact': 4}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+99,Chai-1-Single-Seq,T1158v3,0.8461538461538461,0.9863648057627991,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+100,Chai-1-Single-Seq,H1172v3,,0.0,,
+101,Chai-1-Single-Seq,H1135,29.333333333333336,0.4147157190635452,"{'UNL:ARG:VdWContact': 108, 'UNL:ASN:VdWContact': 108, 'UNL:ASP:VdWContact': 108, 'UNL:GLN:VdWContact': 108, 'UNL:ILE:VdWContact': 108, 'UNL:PRO:VdWContact': 12, 'UNL:SER:VdWContact': 12, 'UNL:TYR:VdWContact': 108, 'UNL:VAL:VdWContact': 192}","{'UNL:ARG:VdWContact': 72, 'UNL:ASN:VdWContact': 144, 'UNL:ASP:VdWContact': 144, 'UNL:GLN:VdWContact': 144, 'UNL:ILE:VdWContact': 108, 'UNL:SER:VdWContact': 36, 'UNL:TYR:VdWContact': 144, 'UNL:VAL:VdWContact': 144}"
+102,Chai-1,H1171v2,,0.0,,
+103,Chai-1,T1158v2,,0.0,,
+104,Chai-1,T1152,1101.9032258064517,0.0,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+105,Chai-1,T1158v1,0.4666666666666667,0.9939799331103679,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2}"
+106,Chai-1,H1171v1,,0.0,,
+107,Chai-1,H1172v1,,0.0,,
+108,Chai-1,T1158v4,1.9999999999999998,0.9632107023411371,"{'UNL:ASN:HBDonor': 4, 'UNL:ASN:VdWContact': 4, 'UNL:GLN:HBAcceptor': 8, 'UNL:GLN:VdWContact': 16, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:HBDonor': 12, 'UNL:GLY:VdWContact': 32, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:HBDonor': 4, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:HBDonor': 4, 'UNL:SER:VdWContact': 28, 'UNL:THR:VdWContact': 8, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:HBDonor': 4, 'UNL:VAL:VdWContact': 8}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+109,Chai-1,H1172v4,,0.0,,
+110,Chai-1,T1146,0.6666666666666666,0.9899665551839465,"{'UNL:ALA:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+111,Chai-1,H1172v2,,0.0,,
+112,Chai-1,T1186,0.625,0.9908026755852842,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 4, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+113,Chai-1,T1187,0.7999999999999999,0.9872909698996656,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 4, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 4, 'UNL:LYS:VdWContact': 10, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 6, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+114,Chai-1,T1127v2,1.4634146341463414,0.9739783016559262,"{'UNL:ALA:HBDonor': 5, 'UNL:ALA:Hydrophobic': 5, 'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBDonor': 10, 'UNL:ARG:Hydrophobic': 10, 'UNL:ARG:VdWContact': 20, 'UNL:CYS:Hydrophobic': 5, 'UNL:CYS:VdWContact': 5, 'UNL:GLN:Hydrophobic': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:HBDonor': 5, 'UNL:GLU:VdWContact': 10, 'UNL:GLY:VdWContact': 10, 'UNL:HIS:HBAcceptor': 5, 'UNL:HIS:HBDonor': 5, 'UNL:HIS:Hydrophobic': 5, 'UNL:HIS:VdWContact': 5, 'UNL:ILE:VdWContact': 10, 'UNL:LEU:Hydrophobic': 15, 'UNL:LEU:VdWContact': 20, 'UNL:LYS:Hydrophobic': 5, 'UNL:LYS:VdWContact': 5, 'UNL:PHE:HBAcceptor': 5, 'UNL:PHE:Hydrophobic': 15, 'UNL:PHE:VdWContact': 25, 'UNL:THR:VdWContact': 15, 'UNL:TRP:Hydrophobic': 5, 'UNL:TRP:VdWContact': 10, 'UNL:VAL:Hydrophobic': 20, 'UNL:VAL:VdWContact': 35}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+115,Chai-1,T1124,,0.0,,
+116,Chai-1,T1158v3,0.8095238095238095,0.987099856665074,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+117,Chai-1,H1172v3,,0.0,,
+118,Chai-1,H1135,37.26315789473684,0.2555888047878895,"{'UNL:ALA:VdWContact': 36, 'UNL:ARG:VdWContact': 60, 'UNL:ASN:VdWContact': 24, 'UNL:ASP:VdWContact': 48, 'UNL:CYS:VdWContact': 12, 'UNL:GLU:VdWContact': 24, 'UNL:GLY:VdWContact': 48, 'UNL:HIS:VdWContact': 12, 'UNL:ILE:VdWContact': 60, 'UNL:LEU:VdWContact': 48, 'UNL:LYS:VdWContact': 12, 'UNL:PHE:VdWContact': 24, 'UNL:PRO:VdWContact': 108, 'UNL:SER:VdWContact': 72, 'UNL:THR:VdWContact': 48, 'UNL:TRP:VdWContact': 12, 'UNL:TYR:VdWContact': 36, 'UNL:VAL:VdWContact': 48}","{'UNL:ARG:VdWContact': 72, 'UNL:ASN:VdWContact': 144, 'UNL:ASP:VdWContact': 144, 'UNL:GLN:VdWContact': 144, 'UNL:ILE:VdWContact': 108, 'UNL:SER:VdWContact': 36, 'UNL:TYR:VdWContact': 144, 'UNL:VAL:VdWContact': 144}"
+119,Boltz-1-Single-Seq,H1171v2,,0.0,,
+120,Boltz-1-Single-Seq,T1158v2,0.75,0.9882943143812709,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+121,Boltz-1-Single-Seq,T1152,1138.8333333333333,0.0,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+122,Boltz-1-Single-Seq,T1158v1,0.6111111111111113,0.9910813823857302,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2}"
+123,Boltz-1-Single-Seq,H1171v1,,0.0,,
+124,Boltz-1-Single-Seq,H1172v1,,0.0,,
+125,Boltz-1-Single-Seq,T1158v4,3.384615384615385,0.9354257782351427,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBDonor': 4, 'UNL:ASN:VdWContact': 4, 'UNL:ASP:HBDonor': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 8, 'UNL:GLY:HBAcceptor': 28, 'UNL:GLY:HBDonor': 12, 'UNL:GLY:VdWContact': 28, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:HBDonor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:HBDonor': 12, 'UNL:SER:VdWContact': 28, 'UNL:THR:HBAcceptor': 4, 'UNL:THR:HBDonor': 4, 'UNL:THR:VdWContact': 12, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:HBDonor': 4, 'UNL:VAL:VdWContact': 8}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+126,Boltz-1-Single-Seq,H1172v4,,0.0,,
+127,Boltz-1-Single-Seq,T1146,0.625,0.9908026755852842,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+128,Boltz-1-Single-Seq,H1172v2,,0.0,,
+129,Boltz-1-Single-Seq,T1186,0.5714285714285713,0.9918776875298615,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:HBDonor': 3, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+130,Boltz-1-Single-Seq,T1187,2.0,0.9632107023411371,"{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:LYS:VdWContact': 4, 'UNL:THR:VdWContact': 4, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:HBDonor': 4, 'UNL:TRP:Hydrophobic': 6, 'UNL:TRP:VdWContact': 12, 'UNL:TYR:Hydrophobic': 4, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+131,Boltz-1-Single-Seq,T1127v2,4.444444444444446,0.9141583054626532,"{'UNL:ALA:Hydrophobic': 10, 'UNL:ARG:HBAcceptor': 20, 'UNL:ARG:HBDonor': 15, 'UNL:ARG:VdWContact': 30, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:HBDonor': 15, 'UNL:ASN:VdWContact': 20, 'UNL:ASP:VdWContact': 10, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:HBDonor': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:Hydrophobic': 20, 'UNL:ILE:VdWContact': 25, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:HBDonor': 5, 'UNL:MET:Hydrophobic': 10, 'UNL:MET:VdWContact': 10, 'UNL:PHE:HBAcceptor': 10, 'UNL:PHE:Hydrophobic': 40, 'UNL:PHE:VdWContact': 35, 'UNL:PRO:VdWContact': 5, 'UNL:TRP:Hydrophobic': 5, 'UNL:TRP:VdWContact': 10, 'UNL:TYR:VdWContact': 10, 'UNL:VAL:Hydrophobic': 5, 'UNL:VAL:VdWContact': 10}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+132,Boltz-1-Single-Seq,T1124,0.96551724137931,0.9839695536846961,"{'UNL:ASN:VdWContact': 8, 'UNL:CYS:VdWContact': 8, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:HBDonor': 8, 'UNL:GLN:VdWContact': 12, 'UNL:GLU:HBDonor': 4, 'UNL:GLU:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 24, 'UNL:MET:Hydrophobic': 8, 'UNL:MET:VdWContact': 8, 'UNL:PHE:Hydrophobic': 12, 'UNL:PHE:VdWContact': 12, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 16}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+133,Boltz-1-Single-Seq,T1158v3,0.7857142857142857,0.9875776397515528,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+134,Boltz-1-Single-Seq,H1172v3,,0.0,,
+135,Boltz-1-Single-Seq,H1135,,0.0,,
+136,Boltz-1,H1171v2,,0.0,,
+137,Boltz-1,T1158v2,0.7333333333333334,0.988628762541806,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+138,Boltz-1,T1152,1177.9655172413795,0.0,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+139,Boltz-1,T1158v1,0.3333333333333333,0.9966555183946488,"{'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2}"
+140,Boltz-1,H1171v1,,0.0,,
+141,Boltz-1,H1172v1,,0.0,,
+142,Boltz-1,T1158v4,2.666666666666666,0.9498327759197325,"{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBDonor': 4, 'UNL:ASN:VdWContact': 4, 'UNL:ASP:HBDonor': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 16, 'UNL:GLN:VdWContact': 12, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:HBDonor': 4, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:HBDonor': 4, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:HBDonor': 12, 'UNL:SER:VdWContact': 28, 'UNL:THR:HBAcceptor': 4, 'UNL:THR:HBDonor': 4, 'UNL:THR:VdWContact': 12, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:VdWContact': 4}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+143,Boltz-1,H1172v4,,0.0,,
+144,Boltz-1,T1146,0.6428571428571429,0.9904443382704252,"{'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+145,Boltz-1,H1172v2,,0.0,,
+146,Boltz-1,T1186,0.5714285714285713,0.9918776875298615,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:HBDonor': 3, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+147,Boltz-1,T1187,1.8333333333333337,0.9665551839464883,"{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:THR:VdWContact': 4, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:HBDonor': 4, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 12, 'UNL:TYR:Hydrophobic': 4, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+148,Boltz-1,T1127v2,4.705882352941176,0.9089120598072005,"{'UNL:ALA:Hydrophobic': 10, 'UNL:ARG:HBAcceptor': 20, 'UNL:ARG:HBDonor': 15, 'UNL:ARG:VdWContact': 30, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:HBDonor': 15, 'UNL:ASN:VdWContact': 20, 'UNL:ASP:VdWContact': 10, 'UNL:GLN:HBDonor': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:HBDonor': 5, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:Hydrophobic': 20, 'UNL:ILE:VdWContact': 25, 'UNL:LEU:Hydrophobic': 10, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 20, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:Hydrophobic': 15, 'UNL:MET:VdWContact': 10, 'UNL:PHE:HBAcceptor': 10, 'UNL:PHE:Hydrophobic': 40, 'UNL:PHE:VdWContact': 40, 'UNL:TRP:Hydrophobic': 10, 'UNL:TRP:VdWContact': 5, 'UNL:TYR:VdWContact': 10}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+149,Boltz-1,T1124,1.5483870967741926,0.9722731686266048,"{'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:HBDonor': 8, 'UNL:ASN:VdWContact': 16, 'UNL:CYS:Hydrophobic': 8, 'UNL:CYS:VdWContact': 8, 'UNL:GLN:HBDonor': 8, 'UNL:GLN:VdWContact': 8, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:ILE:VdWContact': 8, 'UNL:LEU:VdWContact': 32, 'UNL:MET:Hydrophobic': 8, 'UNL:MET:VdWContact': 8, 'UNL:PHE:Hydrophobic': 16, 'UNL:PHE:VdWContact': 12, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 8, 'UNL:TYR:HBDonor': 4, 'UNL:TYR:VdWContact': 8, 'UNL:VAL:Hydrophobic': 8}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+150,Boltz-1,T1158v3,0.8823529411764706,0.9856384025181979,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+151,Boltz-1,H1172v3,,0.0,,
+152,Boltz-1,H1135,,0.0,,
+153,AF3-Single-Seq,H1171v2,12.374999999999998,0.7550167224080268,"{'UNL:ARG:HBAcceptor': 27, 'UNL:ARG:HBDonor': 18, 'UNL:ARG:VdWContact': 45, 'UNL:ASP:VdWContact': 27, 'UNL:GLN:HBAcceptor': 9, 'UNL:GLN:HBDonor': 18, 'UNL:GLN:VdWContact': 27, 'UNL:GLY:HBAcceptor': 90, 'UNL:GLY:HBDonor': 27, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 9, 'UNL:LEU:HBDonor': 18, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:HBDonor': 27, 'UNL:LYS:VdWContact': 45, 'UNL:MET:VdWContact': 9, 'UNL:PHE:VdWContact': 54, 'UNL:PRO:VdWContact': 18, 'UNL:THR:HBAcceptor': 81, 'UNL:THR:HBDonor': 18, 'UNL:THR:VdWContact': 126}","{'UNL:ARG:HBAcceptor': 72, 'UNL:ARG:VdWContact': 81, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 36, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 63, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 162}"
+154,AF3-Single-Seq,T1158v2,,0.0,,
+155,AF3-Single-Seq,T1152,1004.5882352941178,0.0,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+156,AF3-Single-Seq,T1158v1,,0.0,,
+157,AF3-Single-Seq,H1171v1,11.578947368421053,0.7709910227072698,"{'UNL:ASP:VdWContact': 55, 'UNL:GLY:HBAcceptor': 132, 'UNL:GLY:HBDonor': 33, 'UNL:GLY:VdWContact': 187, 'UNL:LEU:HBDonor': 11, 'UNL:LEU:VdWContact': 11, 'UNL:LYS:HBAcceptor': 66, 'UNL:LYS:HBDonor': 44, 'UNL:LYS:VdWContact': 66, 'UNL:PRO:VdWContact': 33, 'UNL:THR:HBAcceptor': 132, 'UNL:THR:HBDonor': 55, 'UNL:THR:VdWContact': 132}","{'UNL:ARG:HBAcceptor': 110, 'UNL:ARG:VdWContact': 99, 'UNL:ASN:VdWContact': 11, 'UNL:ASP:VdWContact': 22, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 121, 'UNL:ILE:VdWContact': 55, 'UNL:LEU:VdWContact': 11, 'UNL:LYS:HBAcceptor': 44, 'UNL:LYS:VdWContact': 44, 'UNL:PRO:Hydrophobic': 44, 'UNL:PRO:VdWContact': 55, 'UNL:THR:HBAcceptor': 88, 'UNL:THR:VdWContact': 231, 'UNL:TYR:VdWContact': 11}"
+158,AF3-Single-Seq,H1172v1,9.409090909090908,0.8145332927941624,"{'UNL:ALA:VdWContact': 9, 'UNL:ASP:VdWContact': 18, 'UNL:GLU:VdWContact': 9, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 36, 'UNL:GLY:VdWContact': 108, 'UNL:LEU:VdWContact': 45, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:HBDonor': 27, 'UNL:LYS:VdWContact': 108, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 90, 'UNL:THR:HBDonor': 27, 'UNL:THR:VdWContact': 99, 'UNL:VAL:HBDonor': 9, 'UNL:VAL:VdWContact': 18}","{'UNL:ARG:HBAcceptor': 54, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 63, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 144, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:VdWContact': 9}"
+159,AF3-Single-Seq,T1158v4,,0.0,,
+160,AF3-Single-Seq,H1172v4,8.571428571428573,0.8313425704730052,"{'UNL:ALA:VdWContact': 9, 'UNL:ASP:VdWContact': 18, 'UNL:GLU:VdWContact': 9, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 36, 'UNL:GLY:VdWContact': 108, 'UNL:LEU:VdWContact': 45, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:HBDonor': 27, 'UNL:LYS:VdWContact': 108, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 90, 'UNL:THR:HBDonor': 9, 'UNL:THR:VdWContact': 99, 'UNL:VAL:VdWContact': 18}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 36, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+161,AF3-Single-Seq,T1146,0.16666666666666669,1.0,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+162,AF3-Single-Seq,H1172v2,14.499999999999998,0.7123745819397993,"{'UNL:ASP:VdWContact': 81, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 36, 'UNL:GLY:VdWContact': 108, 'UNL:LEU:HBDonor': 18, 'UNL:LEU:VdWContact': 90, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:HBDonor': 18, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:VdWContact': 36, 'UNL:THR:HBAcceptor': 135, 'UNL:THR:HBDonor': 36, 'UNL:THR:VdWContact': 162}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:VdWContact': 9, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 27, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+163,AF3-Single-Seq,T1186,,0.0,,
+164,AF3-Single-Seq,T1187,1.0,0.9832775919732442,"{'UNL:ARG:VdWContact': 4, 'UNL:GLU:HBDonor': 4, 'UNL:GLU:Hydrophobic': 4, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 4, 'UNL:LYS:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+165,AF3-Single-Seq,T1127v2,1.184210526315789,0.9795810596725929,"{'UNL:ALA:VdWContact': 15, 'UNL:ARG:HBAcceptor': 20, 'UNL:ARG:HBDonor': 5, 'UNL:ARG:Hydrophobic': 10, 'UNL:ARG:VdWContact': 30, 'UNL:ASN:HBAcceptor': 5, 'UNL:ASN:HBDonor': 5, 'UNL:ASN:Hydrophobic': 5, 'UNL:ASN:VdWContact': 10, 'UNL:GLU:Hydrophobic': 5, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 5, 'UNL:GLY:HBDonor': 10, 'UNL:GLY:VdWContact': 10, 'UNL:HIS:VdWContact': 5, 'UNL:LEU:Hydrophobic': 20, 'UNL:LEU:VdWContact': 15, 'UNL:LYS:VdWContact': 10, 'UNL:PHE:Hydrophobic': 25, 'UNL:PHE:VdWContact': 30, 'UNL:PRO:VdWContact': 5, 'UNL:SER:VdWContact': 10, 'UNL:THR:VdWContact': 5, 'UNL:TYR:HBAcceptor': 5, 'UNL:TYR:HBDonor': 5, 'UNL:TYR:Hydrophobic': 20, 'UNL:TYR:VdWContact': 15, 'UNL:VAL:Hydrophobic': 5}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+166,AF3-Single-Seq,T1124,1.7600000000000002,0.9680267558528428,"{'UNL:ASN:VdWContact': 8, 'UNL:ASP:HBDonor': 4, 'UNL:ASP:Hydrophobic': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLU:Hydrophobic': 8, 'UNL:HIS:Hydrophobic': 8, 'UNL:HIS:VdWContact': 16, 'UNL:ILE:VdWContact': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:HBDonor': 4, 'UNL:LYS:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 8}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+167,AF3-Single-Seq,T1158v3,,0.0,,
+168,AF3-Single-Seq,H1172v3,12.210526315789473,0.7583171976764654,"{'UNL:ARG:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:HBAcceptor': 96, 'UNL:GLY:HBDonor': 16, 'UNL:GLY:VdWContact': 96, 'UNL:LEU:VdWContact': 72, 'UNL:LYS:HBAcceptor': 48, 'UNL:LYS:HBDonor': 16, 'UNL:LYS:VdWContact': 48, 'UNL:PHE:HBDonor': 16, 'UNL:PHE:VdWContact': 40, 'UNL:PRO:VdWContact': 8, 'UNL:THR:HBAcceptor': 96, 'UNL:THR:HBDonor': 32, 'UNL:THR:VdWContact': 96, 'UNL:TYR:VdWContact': 96}","{'UNL:ARG:HBAcceptor': 56, 'UNL:ARG:VdWContact': 64, 'UNL:GLY:HBAcceptor': 64, 'UNL:GLY:VdWContact': 72, 'UNL:ILE:VdWContact': 32, 'UNL:LEU:VdWContact': 24, 'UNL:LYS:HBAcceptor': 40, 'UNL:LYS:VdWContact': 48, 'UNL:PRO:Hydrophobic': 16, 'UNL:PRO:VdWContact': 24, 'UNL:THR:HBAcceptor': 56, 'UNL:THR:VdWContact': 88}"
+169,AF3-Single-Seq,H1135,,0.0,,
+170,AF3,H1171v2,33.0,0.3411371237458194,"{'UNL:ARG:HBAcceptor': 81, 'UNL:ARG:HBDonor': 54, 'UNL:ARG:VdWContact': 135, 'UNL:ASP:VdWContact': 18, 'UNL:GLU:VdWContact': 9, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 72, 'UNL:GLY:VdWContact': 108, 'UNL:ILE:HBAcceptor': 54, 'UNL:ILE:VdWContact': 108, 'UNL:LEU:HBDonor': 54, 'UNL:LEU:VdWContact': 72, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:HBDonor': 18, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:VdWContact': 90, 'UNL:THR:HBAcceptor': 108, 'UNL:THR:VdWContact': 108, 'UNL:TYR:VdWContact': 108}","{'UNL:ARG:HBAcceptor': 72, 'UNL:ARG:VdWContact': 81, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 36, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 63, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 162}"
+171,AF3,T1158v2,,0.0,,
+172,AF3,T1152,1138.6333333333334,0.0,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+173,AF3,T1158v1,,0.0,,
+174,AF3,H1171v1,44.55,0.10936454849498334,"{'UNL:ARG:HBAcceptor': 132, 'UNL:ARG:HBDonor': 77, 'UNL:ARG:VdWContact': 187, 'UNL:ASP:VdWContact': 55, 'UNL:GLY:HBAcceptor': 132, 'UNL:GLY:HBDonor': 77, 'UNL:GLY:VdWContact': 132, 'UNL:ILE:HBAcceptor': 66, 'UNL:ILE:VdWContact': 132, 'UNL:LEU:HBDonor': 66, 'UNL:LEU:VdWContact': 77, 'UNL:LYS:HBAcceptor': 66, 'UNL:LYS:HBDonor': 66, 'UNL:LYS:VdWContact': 66, 'UNL:PRO:VdWContact': 121, 'UNL:THR:HBAcceptor': 132, 'UNL:THR:VdWContact': 132, 'UNL:TYR:VdWContact': 132}","{'UNL:ARG:HBAcceptor': 110, 'UNL:ARG:VdWContact': 99, 'UNL:ASN:VdWContact': 11, 'UNL:ASP:VdWContact': 22, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 121, 'UNL:ILE:VdWContact': 55, 'UNL:LEU:VdWContact': 11, 'UNL:LYS:HBAcceptor': 44, 'UNL:LYS:VdWContact': 44, 'UNL:PRO:Hydrophobic': 44, 'UNL:PRO:VdWContact': 55, 'UNL:THR:HBAcceptor': 88, 'UNL:THR:VdWContact': 231, 'UNL:TYR:VdWContact': 11}"
+175,AF3,H1172v1,33.3,0.3351170568561873,"{'UNL:ARG:HBAcceptor': 90, 'UNL:ARG:HBDonor': 27, 'UNL:ARG:VdWContact': 135, 'UNL:ASP:VdWContact': 9, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 63, 'UNL:GLY:VdWContact': 108, 'UNL:ILE:HBAcceptor': 54, 'UNL:ILE:VdWContact': 108, 'UNL:LEU:HBDonor': 54, 'UNL:LEU:VdWContact': 81, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:HBDonor': 9, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:VdWContact': 81, 'UNL:THR:HBAcceptor': 108, 'UNL:THR:VdWContact': 108, 'UNL:TYR:VdWContact': 108}","{'UNL:ARG:HBAcceptor': 54, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 63, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 144, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:VdWContact': 9}"
+176,AF3,T1158v4,,0.0,,
+177,AF3,H1172v4,30.6,0.38929765886287626,"{'UNL:ARG:HBAcceptor': 90, 'UNL:ARG:HBDonor': 36, 'UNL:ARG:VdWContact': 135, 'UNL:ASP:VdWContact': 9, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 63, 'UNL:GLY:VdWContact': 108, 'UNL:ILE:HBAcceptor': 54, 'UNL:ILE:VdWContact': 108, 'UNL:LEU:HBDonor': 54, 'UNL:LEU:VdWContact': 81, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:HBDonor': 18, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:VdWContact': 81, 'UNL:THR:HBAcceptor': 108, 'UNL:THR:VdWContact': 108, 'UNL:TYR:VdWContact': 108}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 36, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+178,AF3,T1146,0.5555555555555556,0.992196209587514,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+179,AF3,H1172v2,39.0,0.22073578595317722,"{'UNL:ARG:HBAcceptor': 81, 'UNL:ARG:HBDonor': 54, 'UNL:ARG:VdWContact': 126, 'UNL:ASP:VdWContact': 18, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 63, 'UNL:GLY:VdWContact': 108, 'UNL:ILE:HBAcceptor': 54, 'UNL:ILE:VdWContact': 108, 'UNL:LEU:HBDonor': 45, 'UNL:LEU:VdWContact': 45, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:VdWContact': 117, 'UNL:THR:HBAcceptor': 108, 'UNL:THR:VdWContact': 108, 'UNL:TYR:VdWContact': 108}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:VdWContact': 9, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 27, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+180,AF3,T1186,,0.0,,
+181,AF3,T1187,0.9230769230769229,0.9848211988680217,"{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:PRO:Hydrophobic': 4, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 8, 'UNL:TYR:Hydrophobic': 4, 'UNL:VAL:Hydrophobic': 4}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+182,AF3,T1127v2,5.0,0.9030100334448161,"{'UNL:ALA:Hydrophobic': 10, 'UNL:ARG:HBAcceptor': 25, 'UNL:ARG:HBDonor': 10, 'UNL:ARG:VdWContact': 40, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:VdWContact': 30, 'UNL:ASP:VdWContact': 10, 'UNL:GLN:HBDonor': 5, 'UNL:GLN:VdWContact': 5, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:Hydrophobic': 10, 'UNL:ILE:VdWContact': 20, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:Hydrophobic': 10, 'UNL:LYS:VdWContact': 20, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:HBDonor': 5, 'UNL:MET:Hydrophobic': 10, 'UNL:MET:VdWContact': 20, 'UNL:PHE:Hydrophobic': 40, 'UNL:PHE:VdWContact': 45, 'UNL:THR:HBAcceptor': 5, 'UNL:THR:VdWContact': 5, 'UNL:TRP:Hydrophobic': 5, 'UNL:TRP:VdWContact': 10, 'UNL:TYR:VdWContact': 10, 'UNL:VAL:VdWContact': 10}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+183,AF3,T1124,4.363636363636363,0.9157798723016115,"{'UNL:ALA:HBDonor': 4, 'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:Hydrophobic': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:HBDonor': 8, 'UNL:ASP:VdWContact': 16, 'UNL:CYS:VdWContact': 8, 'UNL:GLY:HBDonor': 4, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBDonor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 24, 'UNL:ILE:VdWContact': 16, 'UNL:LEU:Hydrophobic': 16, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:MET:Hydrophobic': 8, 'UNL:MET:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:HBDonor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 16, 'UNL:SER:HBDonor': 4, 'UNL:SER:VdWContact': 8, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 8, 'UNL:TYR:HBAcceptor': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 24, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 12}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+184,AF3,T1158v3,,0.0,,
+185,AF3,H1172v3,34.66666666666666,0.3076923076923078,"{'UNL:ARG:HBAcceptor': 72, 'UNL:ARG:HBDonor': 48, 'UNL:ARG:VdWContact': 112, 'UNL:ASP:VdWContact': 8, 'UNL:GLY:HBAcceptor': 96, 'UNL:GLY:HBDonor': 64, 'UNL:GLY:VdWContact': 96, 'UNL:ILE:HBAcceptor': 48, 'UNL:ILE:VdWContact': 96, 'UNL:LEU:HBDonor': 40, 'UNL:LEU:VdWContact': 40, 'UNL:LYS:HBAcceptor': 48, 'UNL:LYS:VdWContact': 48, 'UNL:PRO:VdWContact': 104, 'UNL:THR:HBAcceptor': 96, 'UNL:THR:VdWContact': 96, 'UNL:TYR:VdWContact': 96}","{'UNL:ARG:HBAcceptor': 56, 'UNL:ARG:VdWContact': 64, 'UNL:GLY:HBAcceptor': 64, 'UNL:GLY:VdWContact': 72, 'UNL:ILE:VdWContact': 32, 'UNL:LEU:VdWContact': 24, 'UNL:LYS:HBAcceptor': 40, 'UNL:LYS:VdWContact': 48, 'UNL:PRO:Hydrophobic': 16, 'UNL:PRO:VdWContact': 24, 'UNL:THR:HBAcceptor': 56, 'UNL:THR:VdWContact': 88}"
+186,AF3,H1135,25.333333333333336,0.49498327759197325,"{'UNL:ARG:VdWContact': 48, 'UNL:ASN:VdWContact': 108, 'UNL:ASP:VdWContact': 108, 'UNL:CYS:VdWContact': 12, 'UNL:GLN:VdWContact': 108, 'UNL:ILE:VdWContact': 108, 'UNL:TYR:VdWContact': 108, 'UNL:VAL:VdWContact': 108}","{'UNL:ARG:VdWContact': 72, 'UNL:ASN:VdWContact': 144, 'UNL:ASP:VdWContact': 144, 'UNL:GLN:VdWContact': 144, 'UNL:ILE:VdWContact': 108, 'UNL:SER:VdWContact': 36, 'UNL:TYR:VdWContact': 144, 'UNL:VAL:VdWContact': 144}"
diff --git a/notebooks/casp15_plif_wm_values.png b/notebooks/casp15_plif_wm_values.png
new file mode 100644
index 00000000..453e6541
Binary files /dev/null and b/notebooks/casp15_plif_wm_values.png differ
diff --git a/notebooks/casp15_public_multi_ligand_relaxed_lddt_pli_violin_plot.png b/notebooks/casp15_public_multi_ligand_relaxed_lddt_pli_violin_plot.png
new file mode 100644
index 00000000..7b8eac3e
Binary files /dev/null and b/notebooks/casp15_public_multi_ligand_relaxed_lddt_pli_violin_plot.png differ
diff --git a/notebooks/casp15_public_multi_ligand_relaxed_pb_valid_bar_chart.png b/notebooks/casp15_public_multi_ligand_relaxed_pb_valid_bar_chart.png
new file mode 100644
index 00000000..dfdef9ed
Binary files /dev/null and b/notebooks/casp15_public_multi_ligand_relaxed_pb_valid_bar_chart.png differ
diff --git a/notebooks/casp15_public_multi_ligand_relaxed_rmsd_lt2_bar_chart.png b/notebooks/casp15_public_multi_ligand_relaxed_rmsd_lt2_bar_chart.png
new file mode 100644
index 00000000..d8a201d8
Binary files /dev/null and b/notebooks/casp15_public_multi_ligand_relaxed_rmsd_lt2_bar_chart.png differ
diff --git a/notebooks/casp15_public_multi_ligand_relaxed_rmsd_violin_plot.png b/notebooks/casp15_public_multi_ligand_relaxed_rmsd_violin_plot.png
new file mode 100644
index 00000000..1db7e520
Binary files /dev/null and b/notebooks/casp15_public_multi_ligand_relaxed_rmsd_violin_plot.png differ
diff --git a/notebooks/casp15_public_single_ligand_relaxed_lddt_pli_violin_plot.png b/notebooks/casp15_public_single_ligand_relaxed_lddt_pli_violin_plot.png
new file mode 100644
index 00000000..b09ada2f
Binary files /dev/null and b/notebooks/casp15_public_single_ligand_relaxed_lddt_pli_violin_plot.png differ
diff --git a/notebooks/casp15_public_single_ligand_relaxed_pb_valid_bar_chart.png b/notebooks/casp15_public_single_ligand_relaxed_pb_valid_bar_chart.png
new file mode 100644
index 00000000..738335d2
Binary files /dev/null and b/notebooks/casp15_public_single_ligand_relaxed_pb_valid_bar_chart.png differ
diff --git a/notebooks/casp15_public_single_ligand_relaxed_rmsd_lt2_bar_chart.png b/notebooks/casp15_public_single_ligand_relaxed_rmsd_lt2_bar_chart.png
new file mode 100644
index 00000000..0049d6ec
Binary files /dev/null and b/notebooks/casp15_public_single_ligand_relaxed_rmsd_lt2_bar_chart.png differ
diff --git a/notebooks/casp15_public_single_ligand_relaxed_rmsd_violin_plot.png b/notebooks/casp15_public_single_ligand_relaxed_rmsd_violin_plot.png
new file mode 100644
index 00000000..d752a876
Binary files /dev/null and b/notebooks/casp15_public_single_ligand_relaxed_rmsd_violin_plot.png differ
diff --git a/notebooks/casp15_structured_plif_metrics.csv b/notebooks/casp15_structured_plif_metrics.csv
new file mode 100644
index 00000000..3e6b24c8
--- /dev/null
+++ b/notebooks/casp15_structured_plif_metrics.csv
@@ -0,0 +1,107 @@
+,Category,Target,Structured_EMD,Unstructured_EMD,Method_Histogram,Reference_Histogram
+0,P2Rank-Vina,T1158v2,1.0,0.6666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+1,P2Rank-Vina,T1152,524.6999999999999,1521.8947368421054,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+2,P2Rank-Vina,T1158v1,0.75,0.6666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2}"
+3,P2Rank-Vina,H1172v1,12.857142857142858,21.000000000000004,"{'UNL:ALA:Hydrophobic': 9, 'UNL:ALA:VdWContact': 18, 'UNL:ARG:HBAcceptor': 36, 'UNL:ARG:HBDonor': 9, 'UNL:ARG:VdWContact': 63, 'UNL:ASN:HBAcceptor': 9, 'UNL:ASN:HBDonor': 9, 'UNL:ASN:VdWContact': 18, 'UNL:ASP:HBAcceptor': 9, 'UNL:ASP:VdWContact': 9, 'UNL:GLN:HBAcceptor': 18, 'UNL:GLN:HBDonor': 9, 'UNL:GLN:VdWContact': 27, 'UNL:GLU:Hydrophobic': 18, 'UNL:GLU:VdWContact': 63, 'UNL:GLY:HBAcceptor': 36, 'UNL:GLY:VdWContact': 45, 'UNL:ILE:HBAcceptor': 9, 'UNL:ILE:HBDonor': 18, 'UNL:ILE:Hydrophobic': 27, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 9, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 54, 'UNL:PRO:VdWContact': 9, 'UNL:SER:VdWContact': 45, 'UNL:THR:HBAcceptor': 36, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 54, 'UNL:TYR:HBDonor': 9, 'UNL:TYR:Hydrophobic': 36, 'UNL:TYR:VdWContact': 54, 'UNL:VAL:VdWContact': 18}","{'UNL:ARG:HBAcceptor': 54, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 63, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 144, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:VdWContact': 9}"
+4,P2Rank-Vina,T1158v4,4.888888888888889,5.666666666666666,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:Hydrophobic': 4, 'UNL:ARG:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 4, 'UNL:GLN:HBDonor': 4, 'UNL:GLN:VdWContact': 8, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 12, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 4, 'UNL:SER:VdWContact': 8, 'UNL:THR:HBAcceptor': 4, 'UNL:THR:Hydrophobic': 4, 'UNL:THR:VdWContact': 8, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:HBAcceptor': 4, 'UNL:TYR:VdWContact': 12, 'UNL:VAL:VdWContact': 4}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+5,P2Rank-Vina,T1146,1.0,0.6,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+6,P2Rank-Vina,T1186,0.6666666666666667,1.1428571428571428,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+7,P2Rank-Vina,T1187,2.0,1.2857142857142856,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 8, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 4, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 4}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+8,P2Rank-Vina,T1127v2,3.333333333333334,7.592592592592592,"{'UNL:ALA:Hydrophobic': 5, 'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 10, 'UNL:ARG:HBDonor': 10, 'UNL:ARG:VdWContact': 30, 'UNL:ASN:HBAcceptor': 15, 'UNL:ASN:Hydrophobic': 5, 'UNL:ASN:VdWContact': 15, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:HBAcceptor': 5, 'UNL:GLN:VdWContact': 5, 'UNL:GLU:HBDonor': 10, 'UNL:GLU:Hydrophobic': 15, 'UNL:GLU:VdWContact': 35, 'UNL:GLY:HBDonor': 5, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:VdWContact': 5, 'UNL:ILE:HBAcceptor': 10, 'UNL:ILE:Hydrophobic': 15, 'UNL:ILE:VdWContact': 25, 'UNL:LEU:Hydrophobic': 30, 'UNL:LEU:VdWContact': 35, 'UNL:MET:HBAcceptor': 5, 'UNL:MET:Hydrophobic': 10, 'UNL:MET:VdWContact': 10, 'UNL:PHE:Hydrophobic': 35, 'UNL:PHE:VdWContact': 40, 'UNL:PRO:Hydrophobic': 5, 'UNL:PRO:VdWContact': 5, 'UNL:TRP:Hydrophobic': 10, 'UNL:TRP:VdWContact': 15, 'UNL:TYR:HBAcceptor': 10, 'UNL:TYR:Hydrophobic': 15, 'UNL:TYR:VdWContact': 15, 'UNL:VAL:VdWContact': 10}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+9,P2Rank-Vina,T1124,2.0,2.2666666666666666,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:HBDonor': 4, 'UNL:ASN:Hydrophobic': 4, 'UNL:ASN:VdWContact': 12, 'UNL:ASP:HBDonor': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:Hydrophobic': 4, 'UNL:GLN:VdWContact': 8, 'UNL:GLU:Hydrophobic': 4, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 12, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:ILE:VdWContact': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:PRO:Hydrophobic': 4, 'UNL:PRO:VdWContact': 4, 'UNL:SER:VdWContact': 8, 'UNL:THR:Hydrophobic': 8, 'UNL:THR:VdWContact': 8, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 8, 'UNL:TYR:HBAcceptor': 4, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 8, 'UNL:VAL:HBDonor': 4, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 8}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+10,DiffDock-L,T1158v2,0.6666666666666667,0.5,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+11,DiffDock-L,T1152,476.72727272727263,1521.6315789473683,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+12,DiffDock-L,T1158v1,1.3333333333333335,0.6999999999999998,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2}"
+13,DiffDock-L,H1172v1,14.142857142857142,18.0,"{'UNL:ALA:VdWContact': 9, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 54, 'UNL:GLY:VdWContact': 54, 'UNL:ILE:HBDonor': 27, 'UNL:ILE:Hydrophobic': 27, 'UNL:ILE:VdWContact': 27, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:VdWContact': 27, 'UNL:PRO:Hydrophobic': 99, 'UNL:PRO:VdWContact': 36, 'UNL:THR:HBAcceptor': 27, 'UNL:THR:VdWContact': 54, 'UNL:TYR:HBDonor': 18, 'UNL:TYR:Hydrophobic': 54, 'UNL:TYR:VdWContact': 54}","{'UNL:ARG:HBAcceptor': 54, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 63, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 144, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:VdWContact': 9}"
+14,DiffDock-L,T1158v4,6.5,6.461538461538461,"{'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 4, 'UNL:GLN:VdWContact': 4, 'UNL:GLY:HBAcceptor': 4, 'UNL:GLY:HBDonor': 4, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 4, 'UNL:LYS:VdWContact': 4, 'UNL:SER:HBAcceptor': 4, 'UNL:SER:HBDonor': 4, 'UNL:SER:VdWContact': 8, 'UNL:THR:VdWContact': 4, 'UNL:TYR:HBAcceptor': 4, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:VdWContact': 4}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+15,DiffDock-L,T1146,0.5,0.4285714285714286,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+16,DiffDock-L,T1186,0.3333333333333333,0.5,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+17,DiffDock-L,T1187,2.0,1.2,"{'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 4}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+18,DiffDock-L,T1127v2,5.0,3.125,"{'UNL:ALA:Hydrophobic': 5, 'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 10, 'UNL:ARG:Hydrophobic': 5, 'UNL:ARG:VdWContact': 20, 'UNL:GLN:HBAcceptor': 5, 'UNL:GLN:Hydrophobic': 5, 'UNL:GLN:VdWContact': 5, 'UNL:GLU:VdWContact': 15, 'UNL:GLY:HBAcceptor': 10, 'UNL:GLY:HBDonor': 5, 'UNL:GLY:VdWContact': 10, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:Hydrophobic': 15, 'UNL:ILE:VdWContact': 15, 'UNL:LEU:Hydrophobic': 10, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:VdWContact': 5, 'UNL:MET:Hydrophobic': 15, 'UNL:MET:VdWContact': 15, 'UNL:PHE:HBDonor': 5, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:Hydrophobic': 10, 'UNL:TRP:VdWContact': 10, 'UNL:TYR:VdWContact': 5}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+19,DiffDock-L,T1124,2.0000000000000004,2.1666666666666665,"{'UNL:ALA:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:Hydrophobic': 4, 'UNL:ASN:VdWContact': 4, 'UNL:ASP:HBDonor': 8, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 8, 'UNL:CYS:VdWContact': 4, 'UNL:GLY:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:ILE:VdWContact': 12, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 4, 'UNL:PHE:HBAcceptor': 4, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:PRO:Hydrophobic': 4, 'UNL:PRO:VdWContact': 4, 'UNL:SER:HBAcceptor': 4, 'UNL:SER:HBDonor': 4, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 12, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 12, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+20,DynamicBind,H1171v2,21.600000000000005,22.0,"{'UNL:ALA:VdWContact': 9, 'UNL:ARG:HBAcceptor': 9, 'UNL:ARG:Hydrophobic': 18, 'UNL:ARG:VdWContact': 45, 'UNL:ASP:Hydrophobic': 9, 'UNL:ASP:VdWContact': 9, 'UNL:GLU:HBAcceptor': 9, 'UNL:GLU:HBDonor': 9, 'UNL:GLU:Hydrophobic': 9, 'UNL:GLU:VdWContact': 27, 'UNL:GLY:HBAcceptor': 36, 'UNL:GLY:HBDonor': 9, 'UNL:GLY:VdWContact': 36, 'UNL:ILE:Hydrophobic': 18, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:HBDonor': 9, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:VdWContact': 18, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 18, 'UNL:THR:HBAcceptor': 27, 'UNL:THR:VdWContact': 36, 'UNL:TYR:HBDonor': 9, 'UNL:TYR:Hydrophobic': 18, 'UNL:TYR:VdWContact': 18}","{'UNL:ARG:HBAcceptor': 72, 'UNL:ARG:VdWContact': 81, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 36, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 63, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 162}"
+21,DynamicBind,T1158v2,0.6666666666666667,0.4615384615384616,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+22,DynamicBind,H1171v1,34.57142857142857,27.500000000000004,"{'UNL:ALA:VdWContact': 11, 'UNL:ARG:HBAcceptor': 22, 'UNL:ARG:Hydrophobic': 22, 'UNL:ARG:VdWContact': 44, 'UNL:ASP:Hydrophobic': 11, 'UNL:ASP:VdWContact': 11, 'UNL:GLU:HBDonor': 11, 'UNL:GLU:Hydrophobic': 11, 'UNL:GLU:VdWContact': 33, 'UNL:GLY:HBAcceptor': 55, 'UNL:GLY:HBDonor': 11, 'UNL:GLY:VdWContact': 55, 'UNL:ILE:Hydrophobic': 22, 'UNL:LEU:HBDonor': 22, 'UNL:LEU:VdWContact': 22, 'UNL:LYS:VdWContact': 22, 'UNL:PRO:Hydrophobic': 22, 'UNL:PRO:VdWContact': 22, 'UNL:THR:HBAcceptor': 22, 'UNL:THR:VdWContact': 33, 'UNL:TYR:Hydrophobic': 44, 'UNL:TYR:VdWContact': 22}","{'UNL:ARG:HBAcceptor': 110, 'UNL:ARG:VdWContact': 99, 'UNL:ASN:VdWContact': 11, 'UNL:ASP:VdWContact': 22, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 121, 'UNL:ILE:VdWContact': 55, 'UNL:LEU:VdWContact': 11, 'UNL:LYS:HBAcceptor': 44, 'UNL:LYS:VdWContact': 44, 'UNL:PRO:Hydrophobic': 44, 'UNL:PRO:VdWContact': 55, 'UNL:THR:HBAcceptor': 88, 'UNL:THR:VdWContact': 231, 'UNL:TYR:VdWContact': 11}"
+23,DynamicBind,H1172v1,18.0,20.399999999999995,"{'UNL:ARG:HBAcceptor': 18, 'UNL:ARG:VdWContact': 36, 'UNL:ASP:VdWContact': 9, 'UNL:GLU:Hydrophobic': 9, 'UNL:GLU:VdWContact': 18, 'UNL:GLY:HBAcceptor': 36, 'UNL:GLY:HBDonor': 9, 'UNL:GLY:VdWContact': 36, 'UNL:ILE:HBDonor': 9, 'UNL:ILE:Hydrophobic': 18, 'UNL:ILE:VdWContact': 9, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:HBDonor': 9, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 9, 'UNL:LYS:VdWContact': 18, 'UNL:PRO:Hydrophobic': 36, 'UNL:PRO:VdWContact': 27, 'UNL:THR:HBAcceptor': 18, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 45, 'UNL:TYR:HBDonor': 9, 'UNL:TYR:Hydrophobic': 27, 'UNL:TYR:VdWContact': 36}","{'UNL:ARG:HBAcceptor': 54, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 63, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 144, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:VdWContact': 9}"
+24,DynamicBind,T1158v4,5.5,4.571428571428572,"{'UNL:ALA:VdWContact': 4, 'UNL:ARG:VdWContact': 12, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:HBAcceptor': 8, 'UNL:GLY:HBDonor': 4, 'UNL:GLY:VdWContact': 12, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 4, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:VdWContact': 4, 'UNL:SER:VdWContact': 8, 'UNL:THR:VdWContact': 4, 'UNL:TRP:VdWContact': 4, 'UNL:VAL:HBDonor': 4, 'UNL:VAL:VdWContact': 8}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+25,DynamicBind,H1172v4,19.800000000000004,13.28571428571429,"{'UNL:ALA:Hydrophobic': 9, 'UNL:ARG:HBAcceptor': 9, 'UNL:ARG:HBDonor': 9, 'UNL:ARG:Hydrophobic': 18, 'UNL:ARG:VdWContact': 54, 'UNL:ASN:Hydrophobic': 9, 'UNL:ASN:VdWContact': 9, 'UNL:ASP:Hydrophobic': 9, 'UNL:ASP:VdWContact': 9, 'UNL:GLU:HBAcceptor': 9, 'UNL:GLU:HBDonor': 9, 'UNL:GLU:Hydrophobic': 9, 'UNL:GLU:VdWContact': 18, 'UNL:GLY:HBAcceptor': 36, 'UNL:GLY:VdWContact': 36, 'UNL:ILE:HBDonor': 9, 'UNL:ILE:Hydrophobic': 18, 'UNL:ILE:VdWContact': 9, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:VdWContact': 27, 'UNL:PRO:Hydrophobic': 36, 'UNL:PRO:VdWContact': 18, 'UNL:SER:VdWContact': 9, 'UNL:THR:HBAcceptor': 54, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 63, 'UNL:TYR:HBDonor': 9, 'UNL:TYR:Hydrophobic': 36, 'UNL:TYR:VdWContact': 36}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 36, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+26,DynamicBind,H1172v2,25.714285714285715,17.4375,"{'UNL:ARG:HBAcceptor': 18, 'UNL:ARG:Hydrophobic': 18, 'UNL:ARG:VdWContact': 63, 'UNL:ASP:VdWContact': 18, 'UNL:GLU:VdWContact': 18, 'UNL:GLY:HBAcceptor': 18, 'UNL:GLY:VdWContact': 36, 'UNL:ILE:HBDonor': 9, 'UNL:ILE:Hydrophobic': 9, 'UNL:ILE:VdWContact': 18, 'UNL:LEU:HBDonor': 9, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:VdWContact': 18, 'UNL:PHE:VdWContact': 9, 'UNL:PRO:Hydrophobic': 36, 'UNL:PRO:VdWContact': 27, 'UNL:THR:HBAcceptor': 27, 'UNL:THR:Hydrophobic': 18, 'UNL:THR:VdWContact': 54, 'UNL:TYR:HBDonor': 9, 'UNL:TYR:Hydrophobic': 18, 'UNL:TYR:VdWContact': 18}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:VdWContact': 9, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 27, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+27,DynamicBind,T1186,0.75,0.7,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+28,DynamicBind,T1187,2.666666666666667,1.2857142857142856,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 4, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+29,DynamicBind,T1127v2,5.454545454545454,2.115384615384616,"{'UNL:ARG:HBAcceptor': 5, 'UNL:ARG:HBDonor': 5, 'UNL:ARG:Hydrophobic': 5, 'UNL:ARG:VdWContact': 15, 'UNL:ASP:Hydrophobic': 5, 'UNL:ASP:VdWContact': 5, 'UNL:GLU:HBDonor': 10, 'UNL:GLU:Hydrophobic': 20, 'UNL:GLU:VdWContact': 20, 'UNL:ILE:Hydrophobic': 10, 'UNL:ILE:VdWContact': 15, 'UNL:LEU:Hydrophobic': 15, 'UNL:LEU:VdWContact': 25, 'UNL:MET:Hydrophobic': 5, 'UNL:MET:VdWContact': 5, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 5, 'UNL:SER:VdWContact': 5, 'UNL:TRP:HBAcceptor': 5, 'UNL:TRP:Hydrophobic': 10, 'UNL:TRP:VdWContact': 15, 'UNL:TYR:HBAcceptor': 5, 'UNL:TYR:Hydrophobic': 10, 'UNL:TYR:VdWContact': 10}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+30,DynamicBind,H1172v3,18.666666666666668,14.588235294117649,"{'UNL:ARG:HBAcceptor': 8, 'UNL:ARG:Hydrophobic': 16, 'UNL:ARG:VdWContact': 40, 'UNL:ASP:VdWContact': 16, 'UNL:GLU:Hydrophobic': 8, 'UNL:GLU:VdWContact': 24, 'UNL:GLY:HBAcceptor': 32, 'UNL:GLY:HBDonor': 8, 'UNL:GLY:VdWContact': 40, 'UNL:ILE:HBDonor': 8, 'UNL:ILE:Hydrophobic': 16, 'UNL:ILE:VdWContact': 8, 'UNL:LEU:HBDonor': 8, 'UNL:LEU:VdWContact': 24, 'UNL:LYS:HBAcceptor': 16, 'UNL:LYS:HBDonor': 8, 'UNL:LYS:Hydrophobic': 8, 'UNL:LYS:VdWContact': 16, 'UNL:PRO:Hydrophobic': 56, 'UNL:PRO:VdWContact': 48, 'UNL:THR:HBAcceptor': 24, 'UNL:THR:Hydrophobic': 24, 'UNL:THR:VdWContact': 40, 'UNL:TYR:HBDonor': 16, 'UNL:TYR:Hydrophobic': 32, 'UNL:TYR:VdWContact': 24}","{'UNL:ARG:HBAcceptor': 56, 'UNL:ARG:VdWContact': 64, 'UNL:GLY:HBAcceptor': 64, 'UNL:GLY:VdWContact': 72, 'UNL:ILE:VdWContact': 32, 'UNL:LEU:VdWContact': 24, 'UNL:LYS:HBAcceptor': 40, 'UNL:LYS:VdWContact': 48, 'UNL:PRO:Hydrophobic': 16, 'UNL:PRO:VdWContact': 24, 'UNL:THR:HBAcceptor': 56, 'UNL:THR:VdWContact': 88}"
+31,NeuralPLexer,H1171v2,22.0,21.315789473684212,"{'UNL:ALA:Hydrophobic': 18, 'UNL:ALA:VdWContact': 9, 'UNL:ARG:HBDonor': 18, 'UNL:ARG:Hydrophobic': 36, 'UNL:ARG:VdWContact': 117, 'UNL:ASN:HBAcceptor': 27, 'UNL:ASN:HBDonor': 27, 'UNL:ASN:VdWContact': 36, 'UNL:GLU:HBDonor': 18, 'UNL:GLU:VdWContact': 18, 'UNL:GLY:HBAcceptor': 27, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:Hydrophobic': 45, 'UNL:ILE:VdWContact': 36, 'UNL:LEU:Hydrophobic': 18, 'UNL:LEU:VdWContact': 90, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:Hydrophobic': 9, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 63, 'UNL:PRO:VdWContact': 63, 'UNL:THR:HBAcceptor': 9, 'UNL:THR:VdWContact': 81, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:Hydrophobic': 27, 'UNL:TYR:VdWContact': 36}","{'UNL:ARG:HBAcceptor': 72, 'UNL:ARG:VdWContact': 81, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 36, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 63, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 162}"
+32,NeuralPLexer,T1158v2,1.0,0.6153846153846154,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+33,NeuralPLexer,T1152,524.6999999999999,1606.5555555555557,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+34,NeuralPLexer,T1158v1,1.3333333333333335,0.6666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2}"
+35,NeuralPLexer,H1171v1,25.666666666666664,22.550000000000004,"{'UNL:ALA:Hydrophobic': 11, 'UNL:ARG:HBDonor': 22, 'UNL:ARG:Hydrophobic': 33, 'UNL:ARG:VdWContact': 121, 'UNL:ASN:HBAcceptor': 44, 'UNL:ASN:Hydrophobic': 22, 'UNL:ASN:VdWContact': 55, 'UNL:ASP:VdWContact': 11, 'UNL:GLU:HBDonor': 22, 'UNL:GLU:VdWContact': 22, 'UNL:GLY:VdWContact': 99, 'UNL:ILE:Hydrophobic': 33, 'UNL:ILE:VdWContact': 33, 'UNL:LEU:HBAcceptor': 11, 'UNL:LEU:HBDonor': 11, 'UNL:LEU:Hydrophobic': 11, 'UNL:LEU:VdWContact': 77, 'UNL:LYS:HBAcceptor': 22, 'UNL:LYS:Hydrophobic': 33, 'UNL:LYS:VdWContact': 55, 'UNL:MET:HBAcceptor': 11, 'UNL:MET:VdWContact': 22, 'UNL:PRO:HBDonor': 11, 'UNL:PRO:Hydrophobic': 44, 'UNL:PRO:VdWContact': 44, 'UNL:THR:HBAcceptor': 22, 'UNL:THR:VdWContact': 132, 'UNL:TYR:HBDonor': 11, 'UNL:TYR:Hydrophobic': 44, 'UNL:TYR:VdWContact': 55}","{'UNL:ARG:HBAcceptor': 110, 'UNL:ARG:VdWContact': 99, 'UNL:ASN:VdWContact': 11, 'UNL:ASP:VdWContact': 22, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 121, 'UNL:ILE:VdWContact': 55, 'UNL:LEU:VdWContact': 11, 'UNL:LYS:HBAcceptor': 44, 'UNL:LYS:VdWContact': 44, 'UNL:PRO:Hydrophobic': 44, 'UNL:PRO:VdWContact': 55, 'UNL:THR:HBAcceptor': 88, 'UNL:THR:VdWContact': 231, 'UNL:TYR:VdWContact': 11}"
+36,NeuralPLexer,H1172v1,15.0,30.705882352941178,"{'UNL:ALA:Hydrophobic': 9, 'UNL:ALA:VdWContact': 9, 'UNL:ARG:HBDonor': 36, 'UNL:ARG:Hydrophobic': 18, 'UNL:ARG:VdWContact': 99, 'UNL:ASN:HBAcceptor': 18, 'UNL:ASN:HBDonor': 18, 'UNL:ASN:VdWContact': 54, 'UNL:GLU:HBDonor': 18, 'UNL:GLU:VdWContact': 18, 'UNL:GLY:HBAcceptor': 36, 'UNL:GLY:VdWContact': 99, 'UNL:ILE:Hydrophobic': 63, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:VdWContact': 99, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:Hydrophobic': 18, 'UNL:LYS:VdWContact': 54, 'UNL:MET:HBAcceptor': 9, 'UNL:PRO:HBDonor': 9, 'UNL:PRO:Hydrophobic': 81, 'UNL:PRO:VdWContact': 81, 'UNL:THR:HBAcceptor': 18, 'UNL:THR:VdWContact': 81, 'UNL:TYR:Hydrophobic': 45, 'UNL:TYR:VdWContact': 27}","{'UNL:ARG:HBAcceptor': 54, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 63, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 144, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:VdWContact': 9}"
+37,NeuralPLexer,T1158v4,4.571428571428571,3.9999999999999996,"{'UNL:ASP:HBDonor': 4, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:HBAcceptor': 12, 'UNL:GLY:VdWContact': 16, 'UNL:LYS:HBAcceptor': 4, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 8, 'UNL:SER:VdWContact': 16, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:HBAcceptor': 4, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:VdWContact': 8}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+38,NeuralPLexer,H1172v4,19.5,18.473684210526315,"{'UNL:ALA:Hydrophobic': 9, 'UNL:ALA:VdWContact': 9, 'UNL:ARG:HBDonor': 27, 'UNL:ARG:Hydrophobic': 18, 'UNL:ARG:VdWContact': 126, 'UNL:ASN:HBAcceptor': 27, 'UNL:ASN:HBDonor': 9, 'UNL:ASN:VdWContact': 27, 'UNL:ASP:VdWContact': 9, 'UNL:GLU:HBDonor': 27, 'UNL:GLU:VdWContact': 27, 'UNL:GLY:HBAcceptor': 9, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:Hydrophobic': 27, 'UNL:ILE:VdWContact': 9, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:HBDonor': 9, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 81, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:HBDonor': 9, 'UNL:LYS:Hydrophobic': 18, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:HBDonor': 18, 'UNL:PRO:Hydrophobic': 54, 'UNL:PRO:VdWContact': 90, 'UNL:THR:HBAcceptor': 18, 'UNL:THR:VdWContact': 90, 'UNL:TYR:Hydrophobic': 45, 'UNL:TYR:VdWContact': 27}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 36, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+39,NeuralPLexer,T1146,0.0,0.4444444444444445,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+40,NeuralPLexer,H1172v2,13.909090909090907,23.57142857142857,"{'UNL:ALA:Hydrophobic': 9, 'UNL:ALA:VdWContact': 9, 'UNL:ARG:HBDonor': 27, 'UNL:ARG:Hydrophobic': 27, 'UNL:ARG:VdWContact': 90, 'UNL:ASN:HBAcceptor': 54, 'UNL:ASN:HBDonor': 27, 'UNL:ASN:VdWContact': 63, 'UNL:ASP:VdWContact': 9, 'UNL:GLU:HBDonor': 27, 'UNL:GLU:VdWContact': 27, 'UNL:GLY:HBAcceptor': 9, 'UNL:GLY:HBDonor': 9, 'UNL:GLY:VdWContact': 99, 'UNL:ILE:Hydrophobic': 45, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 54, 'UNL:LYS:HBAcceptor': 9, 'UNL:LYS:Hydrophobic': 9, 'UNL:LYS:VdWContact': 54, 'UNL:MET:HBAcceptor': 9, 'UNL:MET:Hydrophobic': 9, 'UNL:MET:VdWContact': 18, 'UNL:PRO:HBDonor': 9, 'UNL:PRO:Hydrophobic': 63, 'UNL:PRO:VdWContact': 81, 'UNL:THR:HBAcceptor': 9, 'UNL:THR:VdWContact': 117, 'UNL:TYR:Hydrophobic': 36, 'UNL:TYR:VdWContact': 27}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:VdWContact': 9, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 27, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+41,NeuralPLexer,T1186,1.0,0.375,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+42,NeuralPLexer,T1187,2.0,1.4444444444444446,"{'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 10, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+43,NeuralPLexer,T1127v2,2.727272727272727,3.571428571428572,"{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 20, 'UNL:ARG:HBDonor': 5, 'UNL:ARG:Hydrophobic': 10, 'UNL:ARG:VdWContact': 25, 'UNL:ASN:HBDonor': 5, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 15, 'UNL:GLN:VdWContact': 15, 'UNL:GLU:VdWContact': 25, 'UNL:GLY:HBAcceptor': 10, 'UNL:GLY:HBDonor': 5, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:HBDonor': 5, 'UNL:LYS:VdWContact': 10, 'UNL:MET:Hydrophobic': 10, 'UNL:MET:VdWContact': 10, 'UNL:PHE:Hydrophobic': 30, 'UNL:PHE:VdWContact': 40, 'UNL:TRP:Hydrophobic': 10, 'UNL:TRP:VdWContact': 10, 'UNL:TYR:VdWContact': 10, 'UNL:VAL:VdWContact': 5}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+44,NeuralPLexer,T1124,1.6,2.7692307692307696,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASN:Hydrophobic': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:HBDonor': 4, 'UNL:ASP:Hydrophobic': 4, 'UNL:ASP:VdWContact': 16, 'UNL:CYS:VdWContact': 8, 'UNL:GLN:VdWContact': 4, 'UNL:GLY:VdWContact': 12, 'UNL:HIS:VdWContact': 4, 'UNL:ILE:Hydrophobic': 8, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 12, 'UNL:PHE:HBAcceptor': 4, 'UNL:PHE:Hydrophobic': 16, 'UNL:PHE:VdWContact': 24, 'UNL:PRO:Hydrophobic': 4, 'UNL:PRO:VdWContact': 4, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 16, 'UNL:TYR:HBAcceptor': 4, 'UNL:TYR:VdWContact': 24, 'UNL:VAL:Hydrophobic': 8}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+45,NeuralPLexer,H1172v3,18.909090909090907,25.71428571428572,"{'UNL:ARG:HBAcceptor': 8, 'UNL:ARG:HBDonor': 8, 'UNL:ARG:VdWContact': 88, 'UNL:ASN:HBAcceptor': 16, 'UNL:ASN:HBDonor': 8, 'UNL:ASN:VdWContact': 40, 'UNL:GLU:HBDonor': 16, 'UNL:GLU:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 88, 'UNL:ILE:Hydrophobic': 48, 'UNL:ILE:VdWContact': 32, 'UNL:LEU:HBDonor': 8, 'UNL:LEU:VdWContact': 64, 'UNL:LYS:HBAcceptor': 16, 'UNL:LYS:Hydrophobic': 8, 'UNL:LYS:VdWContact': 32, 'UNL:PRO:HBDonor': 16, 'UNL:PRO:Hydrophobic': 64, 'UNL:PRO:VdWContact': 80, 'UNL:THR:HBAcceptor': 24, 'UNL:THR:HBDonor': 8, 'UNL:THR:VdWContact': 72, 'UNL:TYR:Hydrophobic': 48, 'UNL:TYR:VdWContact': 40}","{'UNL:ARG:HBAcceptor': 56, 'UNL:ARG:VdWContact': 64, 'UNL:GLY:HBAcceptor': 64, 'UNL:GLY:VdWContact': 72, 'UNL:ILE:VdWContact': 32, 'UNL:LEU:VdWContact': 24, 'UNL:LYS:HBAcceptor': 40, 'UNL:LYS:VdWContact': 48, 'UNL:PRO:Hydrophobic': 16, 'UNL:PRO:VdWContact': 24, 'UNL:THR:HBAcceptor': 56, 'UNL:THR:VdWContact': 88}"
+46,RFAA,T1158v2,0.49999999999999994,0.6428571428571429,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+47,RFAA,T1152,582.8888888888889,1807.3125,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+48,RFAA,T1146,0.5,0.5999999999999999,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+49,RFAA,T1187,2.5,2.0,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 6, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:HBDonor': 2, 'UNL:TRP:Hydrophobic': 6, 'UNL:TRP:VdWContact': 10, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+50,RFAA,T1127v2,4.0,3.125,"{'UNL:ALA:HBAcceptor': 5, 'UNL:ALA:HBDonor': 5, 'UNL:ALA:VdWContact': 10, 'UNL:ARG:HBDonor': 5, 'UNL:ARG:VdWContact': 20, 'UNL:ASN:VdWContact': 15, 'UNL:CYS:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:HBDonor': 10, 'UNL:GLU:VdWContact': 30, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:VdWContact': 5, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:HBDonor': 5, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 20, 'UNL:LEU:Hydrophobic': 10, 'UNL:LEU:VdWContact': 20, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 10, 'UNL:PHE:HBDonor': 5, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 25, 'UNL:THR:HBDonor': 5, 'UNL:THR:VdWContact': 5, 'UNL:TRP:Hydrophobic': 10, 'UNL:TRP:VdWContact': 15, 'UNL:TYR:HBDonor': 5, 'UNL:TYR:Hydrophobic': 15, 'UNL:TYR:VdWContact': 15, 'UNL:VAL:VdWContact': 10}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+51,Chai-1-Single-Seq,T1152,436.83333333333337,1521.2105263157894,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 5, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+52,Chai-1-Single-Seq,T1158v4,2.0,4.266666666666667,"{'UNL:ALA:HBDonor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASN:HBDonor': 4, 'UNL:ASN:VdWContact': 4, 'UNL:ASP:HBDonor': 4, 'UNL:ASP:VdWContact': 12, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:HBDonor': 4, 'UNL:GLN:VdWContact': 12, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:HBDonor': 4, 'UNL:GLY:VdWContact': 24, 'UNL:HIS:HBDonor': 4, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:HBDonor': 4, 'UNL:SER:VdWContact': 28, 'UNL:THR:VdWContact': 12, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:VdWContact': 12}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+53,Chai-1-Single-Seq,T1146,0.3333333333333333,1.076923076923077,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+54,Chai-1-Single-Seq,T1186,0.75,0.8571428571428572,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+55,Chai-1-Single-Seq,T1187,2.0,1.1764705882352944,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 4, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+56,Chai-1-Single-Seq,T1127v2,4.6875,6.379310344827586,"{'UNL:ALA:HBAcceptor': 5, 'UNL:ALA:Hydrophobic': 10, 'UNL:ALA:VdWContact': 20, 'UNL:ARG:HBAcceptor': 5, 'UNL:ARG:VdWContact': 10, 'UNL:ASN:HBAcceptor': 5, 'UNL:ASN:Hydrophobic': 5, 'UNL:ASN:VdWContact': 5, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:HBAcceptor': 5, 'UNL:GLN:HBDonor': 5, 'UNL:GLN:Hydrophobic': 5, 'UNL:GLN:VdWContact': 15, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 5, 'UNL:GLY:VdWContact': 10, 'UNL:ILE:HBDonor': 5, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 15, 'UNL:LEU:HBAcceptor': 5, 'UNL:LEU:HBDonor': 5, 'UNL:LEU:Hydrophobic': 25, 'UNL:LEU:VdWContact': 40, 'UNL:LYS:HBDonor': 5, 'UNL:LYS:VdWContact': 5, 'UNL:MET:Hydrophobic': 5, 'UNL:PHE:HBAcceptor': 5, 'UNL:PHE:Hydrophobic': 35, 'UNL:PHE:VdWContact': 50, 'UNL:PRO:Hydrophobic': 5, 'UNL:PRO:VdWContact': 15, 'UNL:SER:VdWContact': 15, 'UNL:THR:HBDonor': 10, 'UNL:THR:Hydrophobic': 5, 'UNL:THR:VdWContact': 15, 'UNL:TYR:Hydrophobic': 5, 'UNL:TYR:VdWContact': 10, 'UNL:VAL:Hydrophobic': 20, 'UNL:VAL:VdWContact': 25}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+57,Chai-1-Single-Seq,T1124,0.666666666666667,3.8260869565217397,"{'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:VdWContact': 4, 'UNL:HIS:VdWContact': 4, 'UNL:ILE:HBAcceptor': 4, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:VdWContact': 4, 'UNL:PRO:Hydrophobic': 4, 'UNL:PRO:VdWContact': 4, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBDonor': 8, 'UNL:THR:Hydrophobic': 4, 'UNL:THR:VdWContact': 12, 'UNL:TYR:HBDonor': 4, 'UNL:TYR:VdWContact': 4}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+58,Chai-1-Single-Seq,T1158v3,0.5,0.909090909090909,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+59,Chai-1,T1152,476.9090909090909,1445.65,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+60,Chai-1,T1158v1,0.25,0.5454545454545454,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2}"
+61,Chai-1,T1158v4,2.1818181818181817,1.846153846153846,"{'UNL:ASN:HBDonor': 4, 'UNL:ASN:VdWContact': 4, 'UNL:GLN:HBAcceptor': 8, 'UNL:GLN:VdWContact': 16, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:HBDonor': 12, 'UNL:GLY:VdWContact': 32, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:HBDonor': 4, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:HBDonor': 4, 'UNL:SER:VdWContact': 28, 'UNL:THR:VdWContact': 8, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:HBDonor': 4, 'UNL:VAL:VdWContact': 8}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+62,Chai-1,T1146,0.5,0.75,"{'UNL:ALA:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+63,Chai-1,T1186,0.6666666666666667,0.8095238095238094,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 4, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+64,Chai-1,T1187,2.0,1.25,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 4, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 4, 'UNL:LYS:VdWContact': 10, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 6, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+65,Chai-1,T1127v2,4.23076923076923,2.678571428571429,"{'UNL:ALA:HBDonor': 5, 'UNL:ALA:Hydrophobic': 5, 'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBDonor': 10, 'UNL:ARG:Hydrophobic': 10, 'UNL:ARG:VdWContact': 20, 'UNL:CYS:Hydrophobic': 5, 'UNL:CYS:VdWContact': 5, 'UNL:GLN:Hydrophobic': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:HBDonor': 5, 'UNL:GLU:VdWContact': 10, 'UNL:GLY:VdWContact': 10, 'UNL:HIS:HBAcceptor': 5, 'UNL:HIS:HBDonor': 5, 'UNL:HIS:Hydrophobic': 5, 'UNL:HIS:VdWContact': 5, 'UNL:ILE:VdWContact': 10, 'UNL:LEU:Hydrophobic': 15, 'UNL:LEU:VdWContact': 20, 'UNL:LYS:Hydrophobic': 5, 'UNL:LYS:VdWContact': 5, 'UNL:PHE:HBAcceptor': 5, 'UNL:PHE:Hydrophobic': 15, 'UNL:PHE:VdWContact': 25, 'UNL:THR:VdWContact': 15, 'UNL:TRP:Hydrophobic': 5, 'UNL:TRP:VdWContact': 10, 'UNL:VAL:Hydrophobic': 20, 'UNL:VAL:VdWContact': 35}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+66,Boltz-1-Single-Seq,T1158v2,0.25,0.9166666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+67,Boltz-1-Single-Seq,T1152,476.9090909090909,1522.0526315789473,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+68,Boltz-1-Single-Seq,T1158v1,0.4,1.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2}"
+69,Boltz-1-Single-Seq,T1158v4,4.0,2.6666666666666674,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBDonor': 4, 'UNL:ASN:VdWContact': 4, 'UNL:ASP:HBDonor': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 8, 'UNL:GLY:HBAcceptor': 28, 'UNL:GLY:HBDonor': 12, 'UNL:GLY:VdWContact': 28, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:HBDonor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:HBDonor': 12, 'UNL:SER:VdWContact': 28, 'UNL:THR:HBAcceptor': 4, 'UNL:THR:HBDonor': 4, 'UNL:THR:VdWContact': 12, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:HBDonor': 4, 'UNL:VAL:VdWContact': 8}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+70,Boltz-1-Single-Seq,T1146,0.0,0.7142857142857142,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+71,Boltz-1-Single-Seq,T1186,1.0,0.4545454545454546,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:HBDonor': 3, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+72,Boltz-1-Single-Seq,T1187,1.3333333333333333,2.2222222222222223,"{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:LYS:VdWContact': 4, 'UNL:THR:VdWContact': 4, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:HBDonor': 4, 'UNL:TRP:Hydrophobic': 6, 'UNL:TRP:VdWContact': 12, 'UNL:TYR:Hydrophobic': 4, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+73,Boltz-1-Single-Seq,T1127v2,4.583333333333335,5.208333333333334,"{'UNL:ALA:Hydrophobic': 10, 'UNL:ARG:HBAcceptor': 20, 'UNL:ARG:HBDonor': 15, 'UNL:ARG:VdWContact': 30, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:HBDonor': 15, 'UNL:ASN:VdWContact': 20, 'UNL:ASP:VdWContact': 10, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:HBDonor': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:Hydrophobic': 20, 'UNL:ILE:VdWContact': 25, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:HBDonor': 5, 'UNL:MET:Hydrophobic': 10, 'UNL:MET:VdWContact': 10, 'UNL:PHE:HBAcceptor': 10, 'UNL:PHE:Hydrophobic': 40, 'UNL:PHE:VdWContact': 35, 'UNL:PRO:VdWContact': 5, 'UNL:TRP:Hydrophobic': 5, 'UNL:TRP:VdWContact': 10, 'UNL:TYR:VdWContact': 10, 'UNL:VAL:Hydrophobic': 5, 'UNL:VAL:VdWContact': 10}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+74,Boltz-1-Single-Seq,T1124,1.3333333333333333,0.8695652173913038,"{'UNL:ASN:VdWContact': 8, 'UNL:CYS:VdWContact': 8, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:HBDonor': 8, 'UNL:GLN:VdWContact': 12, 'UNL:GLU:HBDonor': 4, 'UNL:GLU:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 24, 'UNL:MET:Hydrophobic': 8, 'UNL:MET:VdWContact': 8, 'UNL:PHE:Hydrophobic': 12, 'UNL:PHE:VdWContact': 12, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 16}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+75,Boltz-1-Single-Seq,T1158v3,0.5,0.9999999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+76,Boltz-1,T1158v2,0.33333333333333337,1.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}"
+77,Boltz-1,T1152,524.6999999999999,1521.7894736842106,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+78,Boltz-1,T1158v4,3.0,3.0000000000000004,"{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBDonor': 4, 'UNL:ASN:VdWContact': 4, 'UNL:ASP:HBDonor': 4, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 16, 'UNL:GLN:VdWContact': 12, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:HBDonor': 4, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:HBDonor': 4, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:HBDonor': 12, 'UNL:SER:VdWContact': 28, 'UNL:THR:HBAcceptor': 4, 'UNL:THR:HBDonor': 4, 'UNL:THR:VdWContact': 12, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:VdWContact': 4}","{'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 4, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 4, 'UNL:GLN:HBAcceptor': 12, 'UNL:GLN:VdWContact': 24, 'UNL:GLY:HBAcceptor': 24, 'UNL:GLY:VdWContact': 28, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBAcceptor': 8, 'UNL:LYS:VdWContact': 8, 'UNL:SER:HBAcceptor': 16, 'UNL:SER:VdWContact': 32}"
+79,Boltz-1,T1146,0.0,0.75,"{'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+80,Boltz-1,T1186,1.0,0.4545454545454546,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:HBDonor': 3, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+81,Boltz-1,T1187,1.3333333333333333,2.0,"{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:THR:VdWContact': 4, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:HBDonor': 4, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 12, 'UNL:TYR:Hydrophobic': 4, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+82,Boltz-1,T1127v2,4.166666666666668,5.909090909090909,"{'UNL:ALA:Hydrophobic': 10, 'UNL:ARG:HBAcceptor': 20, 'UNL:ARG:HBDonor': 15, 'UNL:ARG:VdWContact': 30, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:HBDonor': 15, 'UNL:ASN:VdWContact': 20, 'UNL:ASP:VdWContact': 10, 'UNL:GLN:HBDonor': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:HBDonor': 5, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:Hydrophobic': 20, 'UNL:ILE:VdWContact': 25, 'UNL:LEU:Hydrophobic': 10, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 20, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:Hydrophobic': 15, 'UNL:MET:VdWContact': 10, 'UNL:PHE:HBAcceptor': 10, 'UNL:PHE:Hydrophobic': 40, 'UNL:PHE:VdWContact': 40, 'UNL:TRP:Hydrophobic': 10, 'UNL:TRP:VdWContact': 5, 'UNL:TYR:VdWContact': 10}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+83,Boltz-1,T1124,1.3333333333333333,1.6000000000000008,"{'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:HBDonor': 8, 'UNL:ASN:VdWContact': 16, 'UNL:CYS:Hydrophobic': 8, 'UNL:CYS:VdWContact': 8, 'UNL:GLN:HBDonor': 8, 'UNL:GLN:VdWContact': 8, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:ILE:VdWContact': 8, 'UNL:LEU:VdWContact': 32, 'UNL:MET:Hydrophobic': 8, 'UNL:MET:VdWContact': 8, 'UNL:PHE:Hydrophobic': 16, 'UNL:PHE:VdWContact': 12, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 8, 'UNL:TYR:HBDonor': 4, 'UNL:TYR:VdWContact': 8, 'UNL:VAL:Hydrophobic': 8}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+84,Boltz-1,T1158v3,0.3333333333333333,1.0,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+85,AF3-Single-Seq,H1171v2,18.000000000000004,8.999999999999998,"{'UNL:ARG:HBAcceptor': 27, 'UNL:ARG:HBDonor': 18, 'UNL:ARG:VdWContact': 45, 'UNL:ASP:VdWContact': 27, 'UNL:GLN:HBAcceptor': 9, 'UNL:GLN:HBDonor': 18, 'UNL:GLN:VdWContact': 27, 'UNL:GLY:HBAcceptor': 90, 'UNL:GLY:HBDonor': 27, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 9, 'UNL:LEU:HBDonor': 18, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:HBDonor': 27, 'UNL:LYS:VdWContact': 45, 'UNL:MET:VdWContact': 9, 'UNL:PHE:VdWContact': 54, 'UNL:PRO:VdWContact': 18, 'UNL:THR:HBAcceptor': 81, 'UNL:THR:HBDonor': 18, 'UNL:THR:VdWContact': 126}","{'UNL:ARG:HBAcceptor': 72, 'UNL:ARG:VdWContact': 81, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 36, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 63, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 162}"
+86,AF3-Single-Seq,T1152,476.81818181818176,1257.0000000000002,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+87,AF3-Single-Seq,H1171v1,22.0,22.0,"{'UNL:ASP:VdWContact': 55, 'UNL:GLY:HBAcceptor': 132, 'UNL:GLY:HBDonor': 33, 'UNL:GLY:VdWContact': 187, 'UNL:LEU:HBDonor': 11, 'UNL:LEU:VdWContact': 11, 'UNL:LYS:HBAcceptor': 66, 'UNL:LYS:HBDonor': 44, 'UNL:LYS:VdWContact': 66, 'UNL:PRO:VdWContact': 33, 'UNL:THR:HBAcceptor': 132, 'UNL:THR:HBDonor': 55, 'UNL:THR:VdWContact': 132}","{'UNL:ARG:HBAcceptor': 110, 'UNL:ARG:VdWContact': 99, 'UNL:ASN:VdWContact': 11, 'UNL:ASP:VdWContact': 22, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 121, 'UNL:ILE:VdWContact': 55, 'UNL:LEU:VdWContact': 11, 'UNL:LYS:HBAcceptor': 44, 'UNL:LYS:VdWContact': 44, 'UNL:PRO:Hydrophobic': 44, 'UNL:PRO:VdWContact': 55, 'UNL:THR:HBAcceptor': 88, 'UNL:THR:VdWContact': 231, 'UNL:TYR:VdWContact': 11}"
+88,AF3-Single-Seq,H1172v1,13.0,9.69230769230769,"{'UNL:ALA:VdWContact': 9, 'UNL:ASP:VdWContact': 18, 'UNL:GLU:VdWContact': 9, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 36, 'UNL:GLY:VdWContact': 108, 'UNL:LEU:VdWContact': 45, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:HBDonor': 27, 'UNL:LYS:VdWContact': 108, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 90, 'UNL:THR:HBDonor': 27, 'UNL:THR:VdWContact': 99, 'UNL:VAL:HBDonor': 9, 'UNL:VAL:VdWContact': 18}","{'UNL:ARG:HBAcceptor': 54, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 63, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 144, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:VdWContact': 9}"
+89,AF3-Single-Seq,H1172v4,9.0,11.076923076923077,"{'UNL:ALA:VdWContact': 9, 'UNL:ASP:VdWContact': 18, 'UNL:GLU:VdWContact': 9, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 36, 'UNL:GLY:VdWContact': 108, 'UNL:LEU:VdWContact': 45, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:HBDonor': 27, 'UNL:LYS:VdWContact': 108, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 90, 'UNL:THR:HBDonor': 9, 'UNL:THR:VdWContact': 99, 'UNL:VAL:VdWContact': 18}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 36, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+90,AF3-Single-Seq,H1172v2,23.625,18.0,"{'UNL:ASP:VdWContact': 81, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 36, 'UNL:GLY:VdWContact': 108, 'UNL:LEU:HBDonor': 18, 'UNL:LEU:VdWContact': 90, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:HBDonor': 18, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:VdWContact': 36, 'UNL:THR:HBAcceptor': 135, 'UNL:THR:HBDonor': 36, 'UNL:THR:VdWContact': 162}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:VdWContact': 9, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 27, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+91,AF3-Single-Seq,T1187,2.666666666666667,1.2307692307692308,"{'UNL:ARG:VdWContact': 4, 'UNL:GLU:HBDonor': 4, 'UNL:GLU:Hydrophobic': 4, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 4, 'UNL:LYS:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+92,AF3-Single-Seq,T1127v2,3.333333333333333,2.5,"{'UNL:ALA:VdWContact': 15, 'UNL:ARG:HBAcceptor': 20, 'UNL:ARG:HBDonor': 5, 'UNL:ARG:Hydrophobic': 10, 'UNL:ARG:VdWContact': 30, 'UNL:ASN:HBAcceptor': 5, 'UNL:ASN:HBDonor': 5, 'UNL:ASN:Hydrophobic': 5, 'UNL:ASN:VdWContact': 10, 'UNL:GLU:Hydrophobic': 5, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 5, 'UNL:GLY:HBDonor': 10, 'UNL:GLY:VdWContact': 10, 'UNL:HIS:VdWContact': 5, 'UNL:LEU:Hydrophobic': 20, 'UNL:LEU:VdWContact': 15, 'UNL:LYS:VdWContact': 10, 'UNL:PHE:Hydrophobic': 25, 'UNL:PHE:VdWContact': 30, 'UNL:PRO:VdWContact': 5, 'UNL:SER:VdWContact': 10, 'UNL:THR:VdWContact': 5, 'UNL:TYR:HBAcceptor': 5, 'UNL:TYR:HBDonor': 5, 'UNL:TYR:Hydrophobic': 20, 'UNL:TYR:VdWContact': 15, 'UNL:VAL:Hydrophobic': 5}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+93,AF3-Single-Seq,T1124,2.4,1.6000000000000003,"{'UNL:ASN:VdWContact': 8, 'UNL:ASP:HBDonor': 4, 'UNL:ASP:Hydrophobic': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLU:Hydrophobic': 8, 'UNL:HIS:Hydrophobic': 8, 'UNL:HIS:VdWContact': 16, 'UNL:ILE:VdWContact': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:HBDonor': 4, 'UNL:LYS:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 8}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+94,AF3-Single-Seq,H1172v3,17.0,13.09090909090909,"{'UNL:ARG:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:HBAcceptor': 96, 'UNL:GLY:HBDonor': 16, 'UNL:GLY:VdWContact': 96, 'UNL:LEU:VdWContact': 72, 'UNL:LYS:HBAcceptor': 48, 'UNL:LYS:HBDonor': 16, 'UNL:LYS:VdWContact': 48, 'UNL:PHE:HBDonor': 16, 'UNL:PHE:VdWContact': 40, 'UNL:PRO:VdWContact': 8, 'UNL:THR:HBAcceptor': 96, 'UNL:THR:HBDonor': 32, 'UNL:THR:VdWContact': 96, 'UNL:TYR:VdWContact': 96}","{'UNL:ARG:HBAcceptor': 56, 'UNL:ARG:VdWContact': 64, 'UNL:GLY:HBAcceptor': 64, 'UNL:GLY:VdWContact': 72, 'UNL:ILE:VdWContact': 32, 'UNL:LEU:VdWContact': 24, 'UNL:LYS:HBAcceptor': 40, 'UNL:LYS:VdWContact': 48, 'UNL:PRO:Hydrophobic': 16, 'UNL:PRO:VdWContact': 24, 'UNL:THR:HBAcceptor': 56, 'UNL:THR:VdWContact': 88}"
+95,AF3,H1171v2,39.0,28.5,"{'UNL:ARG:HBAcceptor': 81, 'UNL:ARG:HBDonor': 54, 'UNL:ARG:VdWContact': 135, 'UNL:ASP:VdWContact': 18, 'UNL:GLU:VdWContact': 9, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 72, 'UNL:GLY:VdWContact': 108, 'UNL:ILE:HBAcceptor': 54, 'UNL:ILE:VdWContact': 108, 'UNL:LEU:HBDonor': 54, 'UNL:LEU:VdWContact': 72, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:HBDonor': 18, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:VdWContact': 90, 'UNL:THR:HBAcceptor': 108, 'UNL:THR:VdWContact': 108, 'UNL:TYR:VdWContact': 108}","{'UNL:ARG:HBAcceptor': 72, 'UNL:ARG:VdWContact': 81, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 36, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 63, 'UNL:THR:Hydrophobic': 9, 'UNL:THR:VdWContact': 162}"
+96,AF3,T1152,524.6999999999999,1445.6,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:VdWContact': 384, 'UNL:ASN:HBAcceptor': 1152, 'UNL:ASN:VdWContact': 3584, 'UNL:ASP:VdWContact': 1536, 'UNL:GLN:HBAcceptor': 896, 'UNL:GLN:VdWContact': 2560, 'UNL:GLU:HBAcceptor': 128, 'UNL:GLU:VdWContact': 896, 'UNL:GLY:HBAcceptor': 640, 'UNL:GLY:VdWContact': 1920, 'UNL:ILE:HBAcceptor': 512, 'UNL:ILE:VdWContact': 3072, 'UNL:LEU:VdWContact': 1280, 'UNL:LYS:HBAcceptor': 512, 'UNL:LYS:VdWContact': 4224, 'UNL:MET:VdWContact': 1280, 'UNL:PRO:VdWContact': 2432, 'UNL:SER:HBAcceptor': 128, 'UNL:SER:VdWContact': 512, 'UNL:THR:HBAcceptor': 768, 'UNL:THR:VdWContact': 2048, 'UNL:TRP:HBAcceptor': 512, 'UNL:TRP:VdWContact': 768, 'UNL:TYR:VdWContact': 1024, 'UNL:VAL:VdWContact': 1408}"
+97,AF3,H1171v1,52.55555555555556,42.0,"{'UNL:ARG:HBAcceptor': 132, 'UNL:ARG:HBDonor': 77, 'UNL:ARG:VdWContact': 187, 'UNL:ASP:VdWContact': 55, 'UNL:GLY:HBAcceptor': 132, 'UNL:GLY:HBDonor': 77, 'UNL:GLY:VdWContact': 132, 'UNL:ILE:HBAcceptor': 66, 'UNL:ILE:VdWContact': 132, 'UNL:LEU:HBDonor': 66, 'UNL:LEU:VdWContact': 77, 'UNL:LYS:HBAcceptor': 66, 'UNL:LYS:HBDonor': 66, 'UNL:LYS:VdWContact': 66, 'UNL:PRO:VdWContact': 121, 'UNL:THR:HBAcceptor': 132, 'UNL:THR:VdWContact': 132, 'UNL:TYR:VdWContact': 132}","{'UNL:ARG:HBAcceptor': 110, 'UNL:ARG:VdWContact': 99, 'UNL:ASN:VdWContact': 11, 'UNL:ASP:VdWContact': 22, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 121, 'UNL:ILE:VdWContact': 55, 'UNL:LEU:VdWContact': 11, 'UNL:LYS:HBAcceptor': 44, 'UNL:LYS:VdWContact': 44, 'UNL:PRO:Hydrophobic': 44, 'UNL:PRO:VdWContact': 55, 'UNL:THR:HBAcceptor': 88, 'UNL:THR:VdWContact': 231, 'UNL:TYR:VdWContact': 11}"
+98,AF3,H1172v1,33.3,33.3,"{'UNL:ARG:HBAcceptor': 90, 'UNL:ARG:HBDonor': 27, 'UNL:ARG:VdWContact': 135, 'UNL:ASP:VdWContact': 9, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 63, 'UNL:GLY:VdWContact': 108, 'UNL:ILE:HBAcceptor': 54, 'UNL:ILE:VdWContact': 108, 'UNL:LEU:HBDonor': 54, 'UNL:LEU:VdWContact': 81, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:HBDonor': 9, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:VdWContact': 81, 'UNL:THR:HBAcceptor': 108, 'UNL:THR:VdWContact': 108, 'UNL:TYR:VdWContact': 108}","{'UNL:ARG:HBAcceptor': 54, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 63, 'UNL:GLY:VdWContact': 90, 'UNL:ILE:VdWContact': 54, 'UNL:LEU:VdWContact': 18, 'UNL:LYS:HBAcceptor': 36, 'UNL:LYS:VdWContact': 36, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 45, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 144, 'UNL:TYR:HBAcceptor': 9, 'UNL:TYR:VdWContact': 9}"
+99,AF3,H1172v4,29.7,33.3,"{'UNL:ARG:HBAcceptor': 90, 'UNL:ARG:HBDonor': 36, 'UNL:ARG:VdWContact': 135, 'UNL:ASP:VdWContact': 9, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 63, 'UNL:GLY:VdWContact': 108, 'UNL:ILE:HBAcceptor': 54, 'UNL:ILE:VdWContact': 108, 'UNL:LEU:HBDonor': 54, 'UNL:LEU:VdWContact': 81, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:HBDonor': 18, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:VdWContact': 81, 'UNL:THR:HBAcceptor': 108, 'UNL:THR:VdWContact': 108, 'UNL:TYR:VdWContact': 108}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 99, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:HBAcceptor': 9, 'UNL:LEU:VdWContact': 27, 'UNL:LYS:HBAcceptor': 45, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 27, 'UNL:PRO:VdWContact': 36, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+100,AF3,T1146,0.0,0.625,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+101,AF3,H1172v2,41.625,36.89999999999999,"{'UNL:ARG:HBAcceptor': 81, 'UNL:ARG:HBDonor': 54, 'UNL:ARG:VdWContact': 126, 'UNL:ASP:VdWContact': 18, 'UNL:GLY:HBAcceptor': 108, 'UNL:GLY:HBDonor': 63, 'UNL:GLY:VdWContact': 108, 'UNL:ILE:HBAcceptor': 54, 'UNL:ILE:VdWContact': 108, 'UNL:LEU:HBDonor': 45, 'UNL:LEU:VdWContact': 45, 'UNL:LYS:HBAcceptor': 54, 'UNL:LYS:VdWContact': 54, 'UNL:PRO:VdWContact': 117, 'UNL:THR:HBAcceptor': 108, 'UNL:THR:VdWContact': 108, 'UNL:TYR:VdWContact': 108}","{'UNL:ARG:HBAcceptor': 63, 'UNL:ARG:VdWContact': 63, 'UNL:GLY:HBAcceptor': 72, 'UNL:GLY:VdWContact': 81, 'UNL:ILE:VdWContact': 45, 'UNL:LEU:VdWContact': 9, 'UNL:LYS:HBAcceptor': 27, 'UNL:LYS:VdWContact': 45, 'UNL:PRO:Hydrophobic': 18, 'UNL:PRO:VdWContact': 27, 'UNL:THR:HBAcceptor': 72, 'UNL:THR:VdWContact': 135, 'UNL:TYR:VdWContact': 18}"
+102,AF3,T1187,0.0,1.0909090909090906,"{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:PRO:Hydrophobic': 4, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 8, 'UNL:TYR:Hydrophobic': 4, 'UNL:VAL:Hydrophobic': 4}","{'UNL:ALA:HBAcceptor': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 8, 'UNL:TRP:VdWContact': 8, 'UNL:VAL:VdWContact': 2}"
+103,AF3,T1127v2,2.2727272727272725,6.739130434782608,"{'UNL:ALA:Hydrophobic': 10, 'UNL:ARG:HBAcceptor': 25, 'UNL:ARG:HBDonor': 10, 'UNL:ARG:VdWContact': 40, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:VdWContact': 30, 'UNL:ASP:VdWContact': 10, 'UNL:GLN:HBDonor': 5, 'UNL:GLN:VdWContact': 5, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:Hydrophobic': 10, 'UNL:ILE:VdWContact': 20, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:Hydrophobic': 10, 'UNL:LYS:VdWContact': 20, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:HBDonor': 5, 'UNL:MET:Hydrophobic': 10, 'UNL:MET:VdWContact': 20, 'UNL:PHE:Hydrophobic': 40, 'UNL:PHE:VdWContact': 45, 'UNL:THR:HBAcceptor': 5, 'UNL:THR:VdWContact': 5, 'UNL:TRP:Hydrophobic': 5, 'UNL:TRP:VdWContact': 10, 'UNL:TYR:VdWContact': 10, 'UNL:VAL:VdWContact': 10}","{'UNL:ALA:VdWContact': 5, 'UNL:ARG:HBAcceptor': 30, 'UNL:ARG:VdWContact': 35, 'UNL:ASN:HBAcceptor': 10, 'UNL:ASN:Hydrophobic': 10, 'UNL:ASN:VdWContact': 25, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 10, 'UNL:GLU:VdWContact': 20, 'UNL:GLY:HBAcceptor': 20, 'UNL:GLY:VdWContact': 20, 'UNL:ILE:HBAcceptor': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:VdWContact': 10, 'UNL:LYS:HBAcceptor': 10, 'UNL:LYS:VdWContact': 10, 'UNL:MET:HBAcceptor': 10, 'UNL:MET:VdWContact': 15, 'UNL:PHE:VdWContact': 20, 'UNL:TRP:VdWContact': 5, 'UNL:VAL:HBAcceptor': 5, 'UNL:VAL:VdWContact': 5}"
+104,AF3,T1124,3.6,4.695652173913043,"{'UNL:ALA:HBDonor': 4, 'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:Hydrophobic': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:HBDonor': 8, 'UNL:ASP:VdWContact': 16, 'UNL:CYS:VdWContact': 8, 'UNL:GLY:HBDonor': 4, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBDonor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 24, 'UNL:ILE:VdWContact': 16, 'UNL:LEU:Hydrophobic': 16, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:MET:Hydrophobic': 8, 'UNL:MET:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:HBDonor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 16, 'UNL:SER:HBDonor': 4, 'UNL:SER:VdWContact': 8, 'UNL:TRP:Hydrophobic': 8, 'UNL:TRP:VdWContact': 8, 'UNL:TYR:HBAcceptor': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 24, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 12}","{'UNL:ALA:VdWContact': 8, 'UNL:ASN:HBAcceptor': 8, 'UNL:ASN:VdWContact': 8, 'UNL:ASP:VdWContact': 16, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 4, 'UNL:HIS:VdWContact': 8, 'UNL:ILE:Hydrophobic': 8, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 8, 'UNL:PHE:HBAcceptor': 8, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 8, 'UNL:SER:VdWContact': 8, 'UNL:TYR:Hydrophobic': 8, 'UNL:TYR:VdWContact': 20, 'UNL:VAL:Hydrophobic': 8, 'UNL:VAL:VdWContact': 4}"
+105,AF3,H1172v3,37.0,32.8,"{'UNL:ARG:HBAcceptor': 72, 'UNL:ARG:HBDonor': 48, 'UNL:ARG:VdWContact': 112, 'UNL:ASP:VdWContact': 8, 'UNL:GLY:HBAcceptor': 96, 'UNL:GLY:HBDonor': 64, 'UNL:GLY:VdWContact': 96, 'UNL:ILE:HBAcceptor': 48, 'UNL:ILE:VdWContact': 96, 'UNL:LEU:HBDonor': 40, 'UNL:LEU:VdWContact': 40, 'UNL:LYS:HBAcceptor': 48, 'UNL:LYS:VdWContact': 48, 'UNL:PRO:VdWContact': 104, 'UNL:THR:HBAcceptor': 96, 'UNL:THR:VdWContact': 96, 'UNL:TYR:VdWContact': 96}","{'UNL:ARG:HBAcceptor': 56, 'UNL:ARG:VdWContact': 64, 'UNL:GLY:HBAcceptor': 64, 'UNL:GLY:VdWContact': 72, 'UNL:ILE:VdWContact': 32, 'UNL:LEU:VdWContact': 24, 'UNL:LYS:HBAcceptor': 40, 'UNL:LYS:VdWContact': 48, 'UNL:PRO:Hydrophobic': 16, 'UNL:PRO:VdWContact': 24, 'UNL:THR:HBAcceptor': 56, 'UNL:THR:VdWContact': 88}"
diff --git a/notebooks/casp15_structured_vs_unstructured_emd_values.png b/notebooks/casp15_structured_vs_unstructured_emd_values.png
new file mode 100644
index 00000000..a4679a61
Binary files /dev/null and b/notebooks/casp15_structured_vs_unstructured_emd_values.png differ
diff --git a/notebooks/complexes_functional_keywords_1.png b/notebooks/complexes_functional_keywords_1.png
new file mode 100644
index 00000000..150b1bc5
Binary files /dev/null and b/notebooks/complexes_functional_keywords_1.png differ
diff --git a/notebooks/dataset_interaction_analysis_plotting.ipynb b/notebooks/dataset_interaction_analysis_plotting.ipynb
index d10ce466..43582cee 100644
--- a/notebooks/dataset_interaction_analysis_plotting.ipynb
+++ b/notebooks/dataset_interaction_analysis_plotting.ipynb
@@ -76,16 +76,16 @@
")\n",
"assert os.path.exists(\n",
" ad_set_dir\n",
- "), \"Please download the Astex Diverse set from `https://zenodo.org/records/14629652` before proceeding.\"\n",
+ "), \"Please download the Astex Diverse set from `https://zenodo.org/records/16791095` before proceeding.\"\n",
"assert os.path.exists(\n",
" pb_set_dir\n",
- "), \"Please download the PoseBusters Benchmark set from `https://zenodo.org/records/14629652` before proceeding.\"\n",
+ "), \"Please download the PoseBusters Benchmark set from `https://zenodo.org/records/16791095` before proceeding.\"\n",
"assert os.path.exists(\n",
" dg_set_dir\n",
- "), \"Please download the DockGen set from `https://zenodo.org/records/14629652` before proceeding.\"\n",
+ "), \"Please download the DockGen set from `https://zenodo.org/records/16791095` before proceeding.\"\n",
"assert os.path.exists(\n",
" casp15_set_dir\n",
- "), \"Please download the (public) CASP15 set from `https://zenodo.org/records/14629652` before proceeding.\"\n",
+ "), \"Please download the (public) CASP15 set from `https://zenodo.org/records/16791095` before proceeding.\"\n",
"\n",
"CASP15_ANALYSIS_TARGETS_TO_SKIP = [\n",
" \"T1170\"\n",
diff --git a/notebooks/dataset_interaction_analysis_plotting.py b/notebooks/dataset_interaction_analysis_plotting.py
index e650f2b6..34d60932 100644
--- a/notebooks/dataset_interaction_analysis_plotting.py
+++ b/notebooks/dataset_interaction_analysis_plotting.py
@@ -41,16 +41,16 @@
)
assert os.path.exists(
ad_set_dir
-), "Please download the Astex Diverse set from `https://zenodo.org/records/14629652` before proceeding."
+), "Please download the Astex Diverse set from `https://zenodo.org/records/16791095` before proceeding."
assert os.path.exists(
pb_set_dir
-), "Please download the PoseBusters Benchmark set from `https://zenodo.org/records/14629652` before proceeding."
+), "Please download the PoseBusters Benchmark set from `https://zenodo.org/records/16791095` before proceeding."
assert os.path.exists(
dg_set_dir
-), "Please download the DockGen set from `https://zenodo.org/records/14629652` before proceeding."
+), "Please download the DockGen set from `https://zenodo.org/records/16791095` before proceeding."
assert os.path.exists(
casp15_set_dir
-), "Please download the (public) CASP15 set from `https://zenodo.org/records/14629652` before proceeding."
+), "Please download the (public) CASP15 set from `https://zenodo.org/records/16791095` before proceeding."
CASP15_ANALYSIS_TARGETS_TO_SKIP = [
"T1170"
diff --git a/notebooks/dockgen_inference_results_plotting.ipynb b/notebooks/dockgen_inference_results_plotting.ipynb
index 8b1567ae..a3962381 100644
--- a/notebooks/dockgen_inference_results_plotting.ipynb
+++ b/notebooks/dockgen_inference_results_plotting.ipynb
@@ -70,6 +70,8 @@
" \"rfaa\",\n",
" \"chai-lab_ss\",\n",
" \"chai-lab\",\n",
+ " \"boltz_ss\",\n",
+ " \"boltz\",\n",
" \"alphafold3_ss\",\n",
" \"alphafold3\",\n",
"]\n",
@@ -84,6 +86,7 @@
"globals()[\"neuralplexer_output_dir\"] = os.path.join(\"..\", \"forks\", \"NeuralPLexer\", \"inference\")\n",
"globals()[\"rfaa_output_dir\"] = os.path.join(\"..\", \"forks\", \"RoseTTAFold-All-Atom\", \"inference\")\n",
"globals()[\"chai-lab_output_dir\"] = os.path.join(\"..\", \"forks\", \"chai-lab\", \"inference\")\n",
+ "globals()[\"boltz_output_dir\"] = os.path.join(\"..\", \"forks\", \"boltz\", \"inference\")\n",
"globals()[\"alphafold3_output_dir\"] = os.path.join(\"..\", \"forks\", \"alphafold3\", \"inference\")\n",
"for repeat_index in range(1, max_num_repeats_per_method + 1):\n",
" # PLIF metrics\n",
@@ -181,6 +184,30 @@
" \"bust_results.csv\",\n",
" )\n",
"\n",
+ " # Boltz (Single-Seq) results\n",
+ " globals()[f\"boltz_ss_dockgen_bust_results_csv_filepath_{repeat_index}\"] = os.path.join(\n",
+ " globals()[\"boltz_output_dir\"],\n",
+ " f\"boltz_ss_dockgen_outputs_{repeat_index}\",\n",
+ " \"bust_results.csv\",\n",
+ " )\n",
+ " globals()[f\"boltz_ss_dockgen_relaxed_bust_results_csv_filepath_{repeat_index}\"] = os.path.join(\n",
+ " globals()[\"boltz_output_dir\"],\n",
+ " f\"boltz_ss_dockgen_outputs_{repeat_index}_relaxed\",\n",
+ " \"bust_results.csv\",\n",
+ " )\n",
+ "\n",
+ " # Boltz results\n",
+ " globals()[f\"boltz_dockgen_bust_results_csv_filepath_{repeat_index}\"] = os.path.join(\n",
+ " globals()[\"boltz_output_dir\"],\n",
+ " f\"boltz_dockgen_outputs_{repeat_index}\",\n",
+ " \"bust_results.csv\",\n",
+ " )\n",
+ " globals()[f\"boltz_dockgen_relaxed_bust_results_csv_filepath_{repeat_index}\"] = os.path.join(\n",
+ " globals()[\"boltz_output_dir\"],\n",
+ " f\"boltz_dockgen_outputs_{repeat_index}_relaxed\",\n",
+ " \"bust_results.csv\",\n",
+ " )\n",
+ "\n",
" # AlphaFold 3 (Single-Seq) results\n",
" globals()[f\"alphafold3_ss_dockgen_bust_results_csv_filepath_{repeat_index}\"] = os.path.join(\n",
" globals()[\"alphafold3_output_dir\"],\n",
@@ -218,6 +245,8 @@
" \"rfaa\": \"RFAA\",\n",
" \"chai-lab_ss\": \"Chai-1-Single-Seq\",\n",
" \"chai-lab\": \"Chai-1\",\n",
+ " \"boltz_ss\": \"Boltz-1-Single-Seq\",\n",
+ " \"boltz\": \"Boltz-1\",\n",
" \"alphafold3_ss\": \"AF3-Single-Seq\",\n",
" \"alphafold3\": \"AF3\",\n",
"}\n",
@@ -230,6 +259,8 @@
" \"rfaa\": \"DL-based blind\",\n",
" \"chai-lab_ss\": \"DL-based blind\",\n",
" \"chai-lab\": \"DL-based blind\",\n",
+ " \"boltz_ss\": \"DL-based blind\",\n",
+ " \"boltz\": \"DL-based blind\",\n",
" \"alphafold3_ss\": \"DL-based blind\",\n",
" \"alphafold3\": \"DL-based blind\",\n",
"}"
@@ -509,7 +540,7 @@
"colors = [\"#AB8042\", \"#FB8072\", \"#BEBADA\", \"#FCCDE5\"]\n",
"\n",
"bar_width = 0.5\n",
- "r1 = [item - 0.5 for item in range(2, 20, 2)]\n",
+ "r1 = [item - 0.5 for item in range(2, 24, 2)]\n",
"r2 = [x + bar_width for x in r1]\n",
"r3 = [x + bar_width for x in r2]\n",
"\n",
@@ -893,7 +924,7 @@
"\n",
"# add labels, titles, ticks, etc.\n",
"axis.set_ylabel(\"Percentage of predictions\")\n",
- "axis.set_xlim(1, 19 + 0.1)\n",
+ "axis.set_xlim(1, 23 + 0.1)\n",
"axis.set_ylim(0, 125)\n",
"\n",
"assert all(\n",
@@ -1033,7 +1064,7 @@
"axis.grid(axis=\"y\", color=\"#EAEFF8\")\n",
"axis.set_axisbelow(True)\n",
"\n",
- "axis.set_xticks([2, 2 + 1e-3, 4, 6, 8, 10, 11, 12, 14, 16, 18])\n",
+ "axis.set_xticks([2, 2 + 1e-3, 4, 6, 8, 10, 12, 13, 14, 16, 18, 20, 22])\n",
"axis.set_xticks([1 + 0.1], minor=True)\n",
"axis.set_xticklabels(\n",
" [\n",
@@ -1043,9 +1074,11 @@
" \"DynamicBind\",\n",
" \"NeuralPLexer\",\n",
" \"RFAA\",\n",
- " \"DL-based blind\",\n",
" \"Chai-1-Single-Seq\",\n",
+ " \"DL-based blind\",\n",
" \"Chai-1\",\n",
+ " \"Boltz-1-Single-Seq\",\n",
+ " \"Boltz-1\",\n",
" \"AF3-Single-Seq\",\n",
" \"AF3\",\n",
" ]\n",
@@ -1059,7 +1092,7 @@
"axis.tick_params(axis=\"y\", which=\"major\", left=\"off\", right=\"on\", color=\"#EAEFF8\")\n",
"\n",
"# vertical alignment of xtick labels\n",
- "vert_alignments = [0.0, -0.1, 0.0, 0.0, 0.0, 0.0, -0.1, 0.0, 0.0, 0.0, 0.0]\n",
+ "vert_alignments = [0.0, -0.1, 0.0, 0.0, 0.0, 0.0, 0.0, -0.1, 0.0, 0.0, 0.0, 0.0, 0.0]\n",
"for tick, y in zip(axis.get_xticklabels(), vert_alignments):\n",
" tick.set_y(y)\n",
"\n",
diff --git a/notebooks/dockgen_method_interaction_analysis.png b/notebooks/dockgen_method_interaction_analysis.png
new file mode 100644
index 00000000..bd36c4a2
Binary files /dev/null and b/notebooks/dockgen_method_interaction_analysis.png differ
diff --git a/notebooks/dockgen_method_interaction_analysis_plotting.ipynb b/notebooks/dockgen_method_interaction_analysis_plotting.ipynb
index eaac1623..f0d14fad 100644
--- a/notebooks/dockgen_method_interaction_analysis_plotting.ipynb
+++ b/notebooks/dockgen_method_interaction_analysis_plotting.ipynb
@@ -88,6 +88,8 @@
" \"rfaa\",\n",
" \"chai-lab_ss\",\n",
" \"chai-lab\",\n",
+ " \"boltz_ss\",\n",
+ " \"boltz\",\n",
" \"alphafold3_ss\",\n",
" \"alphafold3\",\n",
"]\n",
@@ -102,7 +104,7 @@
")\n",
"assert os.path.exists(\n",
" dg_set_dir\n",
- "), \"Please download the DockGen set from `https://zenodo.org/records/14629652` before proceeding.\"\n",
+ "), \"Please download the DockGen set from `https://zenodo.org/records/16791095` before proceeding.\"\n",
"\n",
"# Mappings\n",
"method_mapping = {\n",
@@ -113,6 +115,8 @@
" \"rfaa\": \"RFAA\",\n",
" \"chai-lab_ss\": \"Chai-1-Single-Seq\",\n",
" \"chai-lab\": \"Chai-1\",\n",
+ " \"boltz_ss\": \"Boltz-1-Single-Seq\",\n",
+ " \"boltz\": \"Boltz-1\",\n",
" \"alphafold3_ss\": \"AF3-Single-Seq\",\n",
" \"alphafold3\": \"AF3\",\n",
"}\n",
diff --git a/notebooks/dockgen_method_interaction_analysis_plotting.py b/notebooks/dockgen_method_interaction_analysis_plotting.py
index 2e9a50de..68e77449 100644
--- a/notebooks/dockgen_method_interaction_analysis_plotting.py
+++ b/notebooks/dockgen_method_interaction_analysis_plotting.py
@@ -53,6 +53,8 @@
"rfaa",
"chai-lab_ss",
"chai-lab",
+ "boltz_ss",
+ "boltz",
"alphafold3_ss",
"alphafold3",
]
@@ -67,7 +69,7 @@
)
assert os.path.exists(
dg_set_dir
-), "Please download the DockGen set from `https://zenodo.org/records/14629652` before proceeding."
+), "Please download the DockGen set from `https://zenodo.org/records/16791095` before proceeding."
# Mappings
method_mapping = {
@@ -78,6 +80,8 @@
"rfaa": "RFAA",
"chai-lab_ss": "Chai-1-Single-Seq",
"chai-lab": "Chai-1",
+ "boltz_ss": "Boltz-1-Single-Seq",
+ "boltz": "Boltz-1",
"alphafold3_ss": "AF3-Single-Seq",
"alphafold3": "AF3",
}
diff --git a/notebooks/dockgen_plif_emd_values.png b/notebooks/dockgen_plif_emd_values.png
new file mode 100644
index 00000000..1ce2a8ee
Binary files /dev/null and b/notebooks/dockgen_plif_emd_values.png differ
diff --git a/notebooks/dockgen_plif_metrics.csv b/notebooks/dockgen_plif_metrics.csv
new file mode 100644
index 00000000..c788cfe9
--- /dev/null
+++ b/notebooks/dockgen_plif_metrics.csv
@@ -0,0 +1,1310 @@
+,Category,Target,EMD,WM,Method_Histogram,Reference_Histogram
+0,P2Rank-Vina,3s6a_1_ANP_0,0.4,0.84,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+1,P2Rank-Vina,2gf3_2_FOA_1,,0.0,,
+2,P2Rank-Vina,1v2g_1_OCA_0,,0.0,,
+3,P2Rank-Vina,2r4e_1_13P_0,,0.0,,
+4,P2Rank-Vina,3ub7_1_ACM_1,,0.0,,
+5,P2Rank-Vina,4cdn_2_FAD_0,,0.0,,
+6,P2Rank-Vina,6yaq_1_OHZ_0,,0.0,,
+7,P2Rank-Vina,4cnl_1_CHT_1,,0.0,,
+8,P2Rank-Vina,5k45_2_GLU_1,,0.0,,
+9,P2Rank-Vina,2zcz_2_TRP_3,,0.0,,
+10,P2Rank-Vina,5fxd_1_H7Y_1,,0.0,,
+11,P2Rank-Vina,5k3o_2_ASP_0,,0.0,,
+12,P2Rank-Vina,5fxe_1_CIY_1,,0.0,,
+13,P2Rank-Vina,5ida_1_BMA_0,,0.0,,
+14,P2Rank-Vina,4osy_1_GLY_3,,0.0,,
+15,P2Rank-Vina,5k62_1_ASN-VAL_0,,0.0,,
+16,P2Rank-Vina,5b5s_1_BOG_0,,0.0,,
+17,P2Rank-Vina,1tke_1_SER_0,,0.0,,
+18,P2Rank-Vina,6paa_1_ASP_2,,0.0,,
+19,P2Rank-Vina,2gag_1_NAD_0,,0.0,,
+20,P2Rank-Vina,6o6y_1_ACK_0,,0.0,,
+21,P2Rank-Vina,3zec_1_ANP_0,,0.0,,
+22,P2Rank-Vina,5mh1_1_BMA_0,,0.0,,
+23,P2Rank-Vina,5dnc_1_ASN_2,,0.0,,
+24,P2Rank-Vina,5u82_2_ZN0_0,,0.0,,
+25,P2Rank-Vina,3wrb_1_GDE_0,,0.0,,
+26,P2Rank-Vina,6ep5_1_ADP_1,,0.0,,
+27,P2Rank-Vina,2vfu_1_MTL_0,,0.0,,
+28,P2Rank-Vina,3zzs_1_TRP_3,,0.0,,
+29,P2Rank-Vina,6ryz_1_SAM_2,,0.0,,
+30,P2Rank-Vina,5hmr_1_FDZ_0,,0.0,,
+31,P2Rank-Vina,2hs3_1_FGR_0,,0.0,,
+32,P2Rank-Vina,6etf_1_AMP_0,,0.0,,
+33,P2Rank-Vina,3jqm_1_GTP_5,,0.0,,
+34,P2Rank-Vina,3eca_1_ASP_3,,0.0,,
+35,P2Rank-Vina,4osx_1_GLY_2,,0.0,,
+36,P2Rank-Vina,2ze9_1_PD7_0,,0.0,,
+37,P2Rank-Vina,5f52_1_ASP_2,,0.0,,
+38,P2Rank-Vina,6xug_1_O1Q_0,,0.0,,
+39,P2Rank-Vina,4fyv_1_DCP_2,,0.0,,
+40,P2Rank-Vina,2hk9_1_SKM_0,,0.0,,
+41,P2Rank-Vina,6v2a_1_ASN_3,,0.0,,
+42,P2Rank-Vina,1rqp_1_SAM_0,,0.0,,
+43,P2Rank-Vina,2wr8_1_SAH_1,,0.0,,
+44,P2Rank-Vina,5gqi_1_ATP_7,,0.0,,
+45,P2Rank-Vina,2vdf_1_OCT_0,,0.0,,
+46,P2Rank-Vina,4qa8_1_PJZ_0,,0.0,,
+47,P2Rank-Vina,5k66_1_ASN-GLU_0,,0.0,,
+48,P2Rank-Vina,3gf4_1_FAD_1,,0.0,,
+49,P2Rank-Vina,4tvd_1_BGC_4,,0.0,,
+50,P2Rank-Vina,1u8u_1_OCA_0,,0.0,,
+51,P2Rank-Vina,2xta_1_ACO_0,,0.0,,
+52,P2Rank-Vina,5hhz_1_ZME_0,,0.0,,
+53,P2Rank-Vina,4xdr_1_ADN_0,,0.0,,
+54,P2Rank-Vina,6uqy_2_AT3_0,,0.0,,
+55,P2Rank-Vina,5k4h_2_GLU_3,,0.0,,
+56,P2Rank-Vina,4tvd_1_GLC_0,,0.0,,
+57,P2Rank-Vina,1pj2_1_FUM_0,,0.0,,
+58,P2Rank-Vina,6o70_1_ACK_1,,0.0,,
+59,P2Rank-Vina,2zd0_1_TRP_9,,0.0,,
+60,P2Rank-Vina,1uf5_1_CDT_0,,0.0,,
+61,P2Rank-Vina,4o95_1_245_0,,0.0,,
+62,P2Rank-Vina,3ad9_1_NAD_0,,0.0,,
+63,P2Rank-Vina,5k63_1_ASN-GLY_0,,0.0,,
+64,P2Rank-Vina,4rpm_1_HXC_0,,0.0,,
+65,P2Rank-Vina,4pfx_1_UDP_0,,0.0,,
+66,P2Rank-Vina,2gah_1_NAD_0,,0.0,,
+67,P2Rank-Vina,6pa2_1_ASP_2,,0.0,,
+68,P2Rank-Vina,4h2f_1_ADN_0,,0.0,,
+69,P2Rank-Vina,4u63_1_FAD_0,,0.0,,
+70,P2Rank-Vina,4o0f_1_GLY_3,,0.0,,
+71,P2Rank-Vina,2q6k_1_ADN_1,,0.0,,
+72,P2Rank-Vina,5fiu_1_Y3J_3,,0.0,,
+73,P2Rank-Vina,5f2t_1_PLM_0,,0.0,,
+74,P2Rank-Vina,3ada_1_NAD_0,,0.0,,
+75,P2Rank-Vina,4b4v_1_L34_0,,0.0,,
+76,P2Rank-Vina,4uoc_1_NCN_1,,0.0,,
+77,P2Rank-Vina,3uni_1_SAL_0,,0.0,,
+78,P2Rank-Vina,3o7j_1_2AL_0,0.49999999999999994,0.8,"{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+79,P2Rank-Vina,2v7v_1_5FD_0,,0.0,,
+80,P2Rank-Vina,4rhe_1_FMN_6,,0.0,,
+81,P2Rank-Vina,5fxf_1_BEZ_0,,0.0,,
+82,P2Rank-Vina,2wwc_1_CHT_2,,0.0,,
+83,P2Rank-Vina,6qkr_1_FAD_0,,0.0,,
+84,P2Rank-Vina,3inr_1_GDU_0,,0.0,,
+85,P2Rank-Vina,4idk_1_1FE_0,,0.0,,
+86,P2Rank-Vina,6yao_1_OJ2_0,,0.0,,
+87,P2Rank-Vina,6ea9_1_9BG_0,,0.0,,
+88,P2Rank-Vina,6ur1_2_AT3_0,,0.0,,
+89,P2Rank-Vina,4mig_1_G3F_2,,0.0,,
+90,P2Rank-Vina,6wyz_1_DGL_1,,0.0,,
+91,P2Rank-Vina,2v7t_1_SAH_4,,0.0,,
+92,P2Rank-Vina,3ad7_1_NAD_0,,0.0,,
+93,P2Rank-Vina,5hw0_1_GLU_2,,0.0,,
+94,P2Rank-Vina,5hqx_1_EDZ_0,,0.0,,
+95,P2Rank-Vina,2q37_1_3AL_0,0.41666666666666674,0.8333333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+96,P2Rank-Vina,6n19_2_K8V_0,,0.0,,
+97,P2Rank-Vina,2v7w_1_5FD_0,,0.0,,
+98,P2Rank-Vina,4phs_1_UDP_0,0.2727272727272727,0.8909090909090909,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+99,P2Rank-Vina,4ydx_1_TCE_0,,0.0,,
+100,P2Rank-Vina,4xfm_1_THE_0,0.4444444444444444,0.8222222222222222,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+101,P2Rank-Vina,3ub9_1_NHY_1,,0.0,,
+102,P2Rank-Vina,1tkg_1_SSA_0,0.4000000000000001,0.84,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+103,P2Rank-Vina,4o0d_1_GLY_3,,0.0,,
+104,P2Rank-Vina,6yap_1_OHZ_0,,0.0,,
+105,P2Rank-Vina,6xb3_3_9BG_1,,0.0,,
+106,P2Rank-Vina,4kgx_1_CTP_5,,0.0,,
+107,P2Rank-Vina,3se5_1_ANP_2,,0.0,,
+108,P2Rank-Vina,6gbf_1_AMP_0,,0.0,,
+109,P2Rank-Vina,2v7u_1_SAM_2,,0.0,,
+110,P2Rank-Vina,2gag_1_FOA_0,,0.0,,
+111,P2Rank-Vina,4uuw_1_AMP_0,,0.0,,
+112,P2Rank-Vina,4phr_1_UDP_0,,0.0,,
+113,P2Rank-Vina,1o72_2_PC_0,0.5714285714285715,0.7714285714285714,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+114,P2Rank-Vina,4oal_2_245_0,,0.0,,
+115,P2Rank-Vina,1hg0_1_SIN_1,,0.0,,
+116,P2Rank-Vina,3zjx_1_BOG_0,,0.0,,
+117,P2Rank-Vina,6pa6_2_ASN_0,,0.0,,
+118,P2Rank-Vina,1qaw_1_TRP_7,,0.0,,
+119,DiffDock-L,3s6a_1_ANP_0,,0.0,,
+120,DiffDock-L,2gf3_2_FOA_1,0.75,0.7,"{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+121,DiffDock-L,1v2g_1_OCA_0,0.5625,0.775,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+122,DiffDock-L,2r4e_1_13P_0,,0.0,,
+123,DiffDock-L,3ub7_1_ACM_1,0.5555555555555556,0.7777777777777778,"{'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+124,DiffDock-L,4cdn_2_FAD_0,0.4782608695652175,0.808695652173913,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+125,DiffDock-L,6yaq_1_OHZ_0,0.823529411764706,0.6705882352941176,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+126,DiffDock-L,4cnl_1_CHT_1,1.0,0.6,"{'UNL:ASP:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}",{}
+127,DiffDock-L,5k45_2_GLU_1,0.1538461538461538,0.9384615384615385,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+128,DiffDock-L,2zcz_2_TRP_3,,0.0,,
+129,DiffDock-L,5fxd_1_H7Y_1,0.6666666666666667,0.7333333333333333,"{'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+130,DiffDock-L,5k3o_2_ASP_0,0.7999999999999999,0.68,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+131,DiffDock-L,5fxe_1_CIY_1,,0.0,,
+132,DiffDock-L,5ida_1_BMA_0,,0.0,,
+133,DiffDock-L,4osy_1_GLY_3,,0.0,,
+134,DiffDock-L,5k62_1_ASN-VAL_0,,0.0,,
+135,DiffDock-L,5b5s_1_BOG_0,0.6153846153846154,0.7538461538461538,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+136,DiffDock-L,1tke_1_SER_0,,0.0,,
+137,DiffDock-L,6paa_1_ASP_2,0.4615384615384614,0.8153846153846154,"{'UNL:ALA:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+138,DiffDock-L,2gag_1_NAD_0,0.4722222222222223,0.8111111111111111,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+139,DiffDock-L,6o6y_1_ACK_0,,0.0,,
+140,DiffDock-L,3zec_1_ANP_0,,0.0,,
+141,DiffDock-L,5mh1_1_BMA_0,,0.0,,
+142,DiffDock-L,5dnc_1_ASN_2,,0.0,,
+143,DiffDock-L,5u82_2_ZN0_0,,0.0,,
+144,DiffDock-L,3wrb_1_GDE_0,,0.0,,
+145,DiffDock-L,6ep5_1_ADP_1,0.4705882352941177,0.8117647058823529,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+146,DiffDock-L,2vfu_1_MTL_0,,0.0,,
+147,DiffDock-L,3zzs_1_TRP_3,,0.0,,
+148,DiffDock-L,6ryz_1_SAM_2,,0.0,,
+149,DiffDock-L,5hmr_1_FDZ_0,0.8999999999999999,0.64,"{'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+150,DiffDock-L,2hs3_1_FGR_0,0.3157894736842105,0.8736842105263158,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+151,DiffDock-L,6etf_1_AMP_0,,0.0,,
+152,DiffDock-L,3jqm_1_GTP_5,,0.0,,
+153,DiffDock-L,3eca_1_ASP_3,,0.0,,
+154,DiffDock-L,4osx_1_GLY_2,,0.0,,
+155,DiffDock-L,2ze9_1_PD7_0,0.9411764705882353,0.6235294117647059,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+156,DiffDock-L,5f52_1_ASP_2,,0.0,,
+157,DiffDock-L,6xug_1_O1Q_0,,0.0,,
+158,DiffDock-L,4fyv_1_DCP_2,0.4166666666666667,0.8333333333333333,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+159,DiffDock-L,2hk9_1_SKM_0,,0.0,,
+160,DiffDock-L,6v2a_1_ASN_3,,0.0,,
+161,DiffDock-L,1rqp_1_SAM_0,,0.0,,
+162,DiffDock-L,2wr8_1_SAH_1,,0.0,,
+163,DiffDock-L,5gqi_1_ATP_7,,0.0,,
+164,DiffDock-L,2vdf_1_OCT_0,1.2857142857142858,0.48571428571428565,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}",{}
+165,DiffDock-L,4qa8_1_PJZ_0,,0.0,,
+166,DiffDock-L,5k66_1_ASN-GLU_0,,0.0,,
+167,DiffDock-L,3gf4_1_FAD_1,0.3666666666666666,0.8533333333333334,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+168,DiffDock-L,4tvd_1_BGC_4,0.7777777777777779,0.6888888888888889,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:VdWContact': 2}","{'UNL:GLU:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+169,DiffDock-L,1u8u_1_OCA_0,0.5714285714285714,0.7714285714285715,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+170,DiffDock-L,2xta_1_ACO_0,0.42857142857142855,0.8285714285714285,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+171,DiffDock-L,5hhz_1_ZME_0,0.7000000000000001,0.72,"{'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2}"
+172,DiffDock-L,4xdr_1_ADN_0,,0.0,,
+173,DiffDock-L,6uqy_2_AT3_0,0.14285714285714282,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+174,DiffDock-L,5k4h_2_GLU_3,0.24999999999999994,0.9,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+175,DiffDock-L,4tvd_1_GLC_0,0.5714285714285714,0.7714285714285715,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LYS:VdWContact': 2}"
+176,DiffDock-L,1pj2_1_FUM_0,,0.0,,
+177,DiffDock-L,6o70_1_ACK_1,0.11111111111111116,0.9555555555555555,"{'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+178,DiffDock-L,2zd0_1_TRP_9,0.4666666666666666,0.8133333333333334,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+179,DiffDock-L,1uf5_1_CDT_0,,0.0,,
+180,DiffDock-L,4o95_1_245_0,,0.0,,
+181,DiffDock-L,3ad9_1_NAD_0,0.4666666666666666,0.8133333333333334,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+182,DiffDock-L,5k63_1_ASN-GLY_0,,0.0,,
+183,DiffDock-L,4rpm_1_HXC_0,,0.0,,
+184,DiffDock-L,4pfx_1_UDP_0,0.23529411764705874,0.9058823529411765,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+185,DiffDock-L,2gah_1_NAD_0,,0.0,,
+186,DiffDock-L,6pa2_1_ASP_2,,0.0,,
+187,DiffDock-L,4h2f_1_ADN_0,,0.0,,
+188,DiffDock-L,4u63_1_FAD_0,0.4838709677419356,0.8064516129032258,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+189,DiffDock-L,4o0f_1_GLY_3,,0.0,,
+190,DiffDock-L,2q6k_1_ADN_1,,0.0,,
+191,DiffDock-L,5fiu_1_Y3J_3,,0.0,,
+192,DiffDock-L,5f2t_1_PLM_0,1.1111111111111112,0.5555555555555556,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+193,DiffDock-L,3ada_1_NAD_0,0.45454545454545436,0.8181818181818182,"{'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+194,DiffDock-L,4b4v_1_L34_0,0.20000000000000007,0.9199999999999999,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+195,DiffDock-L,4uoc_1_NCN_1,0.4444444444444444,0.8222222222222222,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 4, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+196,DiffDock-L,3uni_1_SAL_0,,0.0,,
+197,DiffDock-L,3o7j_1_2AL_0,,0.0,,
+198,DiffDock-L,2v7v_1_5FD_0,0.2857142857142857,0.8857142857142857,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+199,DiffDock-L,4rhe_1_FMN_6,,0.0,,
+200,DiffDock-L,5fxf_1_BEZ_0,0.19999999999999996,0.92,"{'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+201,DiffDock-L,2wwc_1_CHT_2,1.0,0.6,"{'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}",{}
+202,DiffDock-L,6qkr_1_FAD_0,,0.0,,
+203,DiffDock-L,3inr_1_GDU_0,0.39999999999999997,0.8400000000000001,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+204,DiffDock-L,4idk_1_1FE_0,0.3999999999999999,0.8400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1}","{'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 2}"
+205,DiffDock-L,6yao_1_OJ2_0,,0.0,,
+206,DiffDock-L,6ea9_1_9BG_0,,0.0,,
+207,DiffDock-L,6ur1_2_AT3_0,0.8666666666666666,0.6533333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+208,DiffDock-L,4mig_1_G3F_2,,0.0,,
+209,DiffDock-L,6wyz_1_DGL_1,0.46153846153846156,0.8153846153846154,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+210,DiffDock-L,2v7t_1_SAH_4,0.34782608695652173,0.8608695652173913,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+211,DiffDock-L,3ad7_1_NAD_0,0.4285714285714286,0.8285714285714285,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 6, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+212,DiffDock-L,5hw0_1_GLU_2,0.5555555555555556,0.7777777777777778,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+213,DiffDock-L,5hqx_1_EDZ_0,0.4615384615384614,0.8153846153846154,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+214,DiffDock-L,2q37_1_3AL_0,,0.0,,
+215,DiffDock-L,6n19_2_K8V_0,,0.0,,
+216,DiffDock-L,2v7w_1_5FD_0,0.38095238095238093,0.8476190476190476,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+217,DiffDock-L,4phs_1_UDP_0,,0.0,,
+218,DiffDock-L,4ydx_1_TCE_0,,0.0,,
+219,DiffDock-L,4xfm_1_THE_0,,0.0,,
+220,DiffDock-L,3ub9_1_NHY_1,0.888888888888889,0.6444444444444444,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 2}"
+221,DiffDock-L,1tkg_1_SSA_0,,0.0,,
+222,DiffDock-L,4o0d_1_GLY_3,,0.0,,
+223,DiffDock-L,6yap_1_OHZ_0,0.7058823529411765,0.7176470588235294,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+224,DiffDock-L,6xb3_3_9BG_1,,0.0,,
+225,DiffDock-L,4kgx_1_CTP_5,0.3333333333333333,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+226,DiffDock-L,3se5_1_ANP_2,0.4666666666666667,0.8133333333333334,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+227,DiffDock-L,6gbf_1_AMP_0,,0.0,,
+228,DiffDock-L,2v7u_1_SAM_2,0.34782608695652173,0.8608695652173913,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+229,DiffDock-L,2gag_1_FOA_0,,0.0,,
+230,DiffDock-L,4uuw_1_AMP_0,0.5882352941176472,0.7647058823529411,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+231,DiffDock-L,4phr_1_UDP_0,0.375,0.85,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+232,DiffDock-L,1o72_2_PC_0,,0.0,,
+233,DiffDock-L,4oal_2_245_0,,0.0,,
+234,DiffDock-L,1hg0_1_SIN_1,0.5833333333333333,0.7666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+235,DiffDock-L,3zjx_1_BOG_0,0.6666666666666667,0.7333333333333333,{'UNL:LYS:VdWContact': 1},"{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+236,DiffDock-L,6pa6_2_ASN_0,,0.0,,
+237,DiffDock-L,1qaw_1_TRP_7,0.6666666666666667,0.7333333333333333,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
+238,DynamicBind,3s6a_1_ANP_0,0.25,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+239,DynamicBind,2gf3_2_FOA_1,0.75,0.7,"{'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:GLN:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+240,DynamicBind,1v2g_1_OCA_0,0.4,0.84,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+241,DynamicBind,2r4e_1_13P_0,0.6363636363636364,0.7454545454545455,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+242,DynamicBind,3ub7_1_ACM_1,0.49999999999999994,0.8,"{'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+243,DynamicBind,4cdn_2_FAD_0,0.40909090909090906,0.8363636363636364,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+244,DynamicBind,6yaq_1_OHZ_0,0.9285714285714287,0.6285714285714286,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+245,DynamicBind,4cnl_1_CHT_1,1.3333333333333335,0.46666666666666656,"{'UNL:ASP:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}",{}
+246,DynamicBind,5k45_2_GLU_1,0.08333333333333337,0.9666666666666667,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+247,DynamicBind,2zcz_2_TRP_3,0.55,0.78,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+248,DynamicBind,5fxd_1_H7Y_1,0.44444444444444453,0.8222222222222222,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+249,DynamicBind,5k3o_2_ASP_0,1.0,0.6,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+250,DynamicBind,5fxe_1_CIY_1,0.375,0.85,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+251,DynamicBind,5ida_1_BMA_0,0.3,0.88,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+252,DynamicBind,4osy_1_GLY_3,,0.0,,
+253,DynamicBind,5k62_1_ASN-VAL_0,,0.0,,
+254,DynamicBind,5b5s_1_BOG_0,0.49999999999999994,0.8,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+255,DynamicBind,1tke_1_SER_0,0.8571428571428572,0.6571428571428571,"{'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+256,DynamicBind,6paa_1_ASP_2,0.19999999999999996,0.92,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+257,DynamicBind,2gag_1_NAD_0,0.2083333333333333,0.9166666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+258,DynamicBind,6o6y_1_ACK_0,0.846153846153846,0.6615384615384616,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+259,DynamicBind,3zec_1_ANP_0,0.5833333333333333,0.7666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+260,DynamicBind,5mh1_1_BMA_0,,0.0,,
+261,DynamicBind,5dnc_1_ASN_2,,0.0,,
+262,DynamicBind,5u82_2_ZN0_0,,0.0,,
+263,DynamicBind,3wrb_1_GDE_0,0.3846153846153846,0.8461538461538461,"{'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+264,DynamicBind,6ep5_1_ADP_1,0.46666666666666673,0.8133333333333332,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+265,DynamicBind,2vfu_1_MTL_0,0.1333333333333333,0.9466666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+266,DynamicBind,3zzs_1_TRP_3,,0.0,,
+267,DynamicBind,6ryz_1_SAM_2,0.20833333333333331,0.9166666666666666,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+268,DynamicBind,5hmr_1_FDZ_0,1.0,0.6,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+269,DynamicBind,2hs3_1_FGR_0,0.7333333333333334,0.7066666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+270,DynamicBind,6etf_1_AMP_0,,0.0,,
+271,DynamicBind,3jqm_1_GTP_5,0.9333333333333333,0.6266666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+272,DynamicBind,3eca_1_ASP_3,0.29411764705882343,0.8823529411764707,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+273,DynamicBind,4osx_1_GLY_2,,0.0,,
+274,DynamicBind,2ze9_1_PD7_0,0.7272727272727274,0.709090909090909,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+275,DynamicBind,5f52_1_ASP_2,,0.0,,
+276,DynamicBind,6xug_1_O1Q_0,,0.0,,
+277,DynamicBind,4fyv_1_DCP_2,0.625,0.75,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+278,DynamicBind,2hk9_1_SKM_0,0.4000000000000001,0.84,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+279,DynamicBind,6v2a_1_ASN_3,,0.0,,
+280,DynamicBind,1rqp_1_SAM_0,0.37037037037037035,0.8518518518518519,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+281,DynamicBind,2wr8_1_SAH_1,0.30000000000000004,0.88,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+282,DynamicBind,5gqi_1_ATP_7,0.6111111111111112,0.7555555555555555,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+283,DynamicBind,2vdf_1_OCT_0,2.0,0.19999999999999996,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3}",{}
+284,DynamicBind,4qa8_1_PJZ_0,2.1052631578947367,0.1578947368421053,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 6, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+285,DynamicBind,5k66_1_ASN-GLU_0,,0.0,,
+286,DynamicBind,3gf4_1_FAD_1,0.3103448275862069,0.8758620689655172,"{'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+287,DynamicBind,4tvd_1_BGC_4,,0.0,,
+288,DynamicBind,1u8u_1_OCA_0,0.3571428571428572,0.8571428571428571,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+289,DynamicBind,2xta_1_ACO_0,0.375,0.85,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+290,DynamicBind,5hhz_1_ZME_0,1.1666666666666665,0.5333333333333334,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2}"
+291,DynamicBind,4xdr_1_ADN_0,,0.0,,
+292,DynamicBind,6uqy_2_AT3_0,0.19999999999999996,0.92,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+293,DynamicBind,5k4h_2_GLU_3,0.39999999999999997,0.8400000000000001,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+294,DynamicBind,4tvd_1_GLC_0,,0.0,,
+295,DynamicBind,1pj2_1_FUM_0,,0.0,,
+296,DynamicBind,6o70_1_ACK_1,0.23076923076923073,0.9076923076923077,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+297,DynamicBind,2zd0_1_TRP_9,0.6666666666666667,0.7333333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+298,DynamicBind,1uf5_1_CDT_0,0.125,0.95,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+299,DynamicBind,4o95_1_245_0,1.1666666666666665,0.5333333333333334,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}",{'UNL:ASP:VdWContact': 1}
+300,DynamicBind,3ad9_1_NAD_0,0.17241379310344818,0.9310344827586208,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+301,DynamicBind,5k63_1_ASN-GLY_0,,0.0,,
+302,DynamicBind,4rpm_1_HXC_0,,0.0,,
+303,DynamicBind,4pfx_1_UDP_0,,0.0,,
+304,DynamicBind,2gah_1_NAD_0,0.40625,0.8375,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+305,DynamicBind,6pa2_1_ASP_2,,0.0,,
+306,DynamicBind,4h2f_1_ADN_0,0.75,0.7,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+307,DynamicBind,4u63_1_FAD_0,,0.0,,
+308,DynamicBind,4o0f_1_GLY_3,,0.0,,
+309,DynamicBind,2q6k_1_ADN_1,0.26666666666666666,0.8933333333333333,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+310,DynamicBind,5fiu_1_Y3J_3,0.1111111111111111,0.9555555555555556,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+311,DynamicBind,5f2t_1_PLM_0,1.2307692307692308,0.5076923076923077,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+312,DynamicBind,3ada_1_NAD_0,0.1111111111111111,0.9555555555555556,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+313,DynamicBind,4b4v_1_L34_0,0.2608695652173912,0.8956521739130435,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+314,DynamicBind,4uoc_1_NCN_1,0.5882352941176471,0.7647058823529411,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+315,DynamicBind,3uni_1_SAL_0,,0.0,,
+316,DynamicBind,3o7j_1_2AL_0,0.27272727272727265,0.890909090909091,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+317,DynamicBind,2v7v_1_5FD_0,0.3157894736842105,0.8736842105263158,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+318,DynamicBind,4rhe_1_FMN_6,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+319,DynamicBind,5fxf_1_BEZ_0,0.27272727272727276,0.8909090909090909,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+320,DynamicBind,2wwc_1_CHT_2,1.6666666666666667,0.33333333333333326,"{'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 2, 'UNL:TYR:VdWContact': 1}",{}
+321,DynamicBind,6qkr_1_FAD_0,0.1071428571428571,0.9571428571428572,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+322,DynamicBind,3inr_1_GDU_0,0.42857142857142855,0.8285714285714285,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+323,DynamicBind,4idk_1_1FE_0,,0.0,,
+324,DynamicBind,6yao_1_OJ2_0,0.7333333333333333,0.7066666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+325,DynamicBind,6ea9_1_9BG_0,0.36,0.856,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+326,DynamicBind,6ur1_2_AT3_0,0.8333333333333333,0.6666666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+327,DynamicBind,4mig_1_G3F_2,,0.0,,
+328,DynamicBind,6wyz_1_DGL_1,0.5833333333333334,0.7666666666666666,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+329,DynamicBind,2v7t_1_SAH_4,0.21739130434782616,0.9130434782608695,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+330,DynamicBind,3ad7_1_NAD_0,0.2,0.92,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+331,DynamicBind,5hw0_1_GLU_2,0.21428571428571427,0.9142857142857143,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+332,DynamicBind,5hqx_1_EDZ_0,0.5333333333333333,0.7866666666666666,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+333,DynamicBind,2q37_1_3AL_0,0.2727272727272728,0.8909090909090909,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+334,DynamicBind,6n19_2_K8V_0,,0.0,,
+335,DynamicBind,2v7w_1_5FD_0,0.14999999999999997,0.9400000000000001,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+336,DynamicBind,4phs_1_UDP_0,0.35294117647058826,0.8588235294117648,"{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+337,DynamicBind,4ydx_1_TCE_0,0.6666666666666666,0.7333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}"
+338,DynamicBind,4xfm_1_THE_0,0.28571428571428564,0.8857142857142858,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+339,DynamicBind,3ub9_1_NHY_1,0.5,0.8,"{'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 2}"
+340,DynamicBind,1tkg_1_SSA_0,0.6111111111111112,0.7555555555555555,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+341,DynamicBind,4o0d_1_GLY_3,,0.0,,
+342,DynamicBind,6yap_1_OHZ_0,0.6470588235294117,0.7411764705882353,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+343,DynamicBind,6xb3_3_9BG_1,0.4500000000000002,0.82,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 3, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+344,DynamicBind,4kgx_1_CTP_5,0.55,0.78,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+345,DynamicBind,3se5_1_ANP_2,0.3125,0.875,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+346,DynamicBind,6gbf_1_AMP_0,,0.0,,
+347,DynamicBind,2v7u_1_SAM_2,0.3749999999999999,0.8500000000000001,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+348,DynamicBind,2gag_1_FOA_0,0.5625,0.775,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+349,DynamicBind,4uuw_1_AMP_0,0.5,0.8,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+350,DynamicBind,4phr_1_UDP_0,0.4285714285714285,0.8285714285714286,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+351,DynamicBind,1o72_2_PC_0,,0.0,,
+352,DynamicBind,4oal_2_245_0,1.166666666666667,0.5333333333333332,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1}"
+353,DynamicBind,1hg0_1_SIN_1,0.7,0.72,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+354,DynamicBind,3zjx_1_BOG_0,0.16666666666666669,0.9333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+355,DynamicBind,6pa6_2_ASN_0,,0.0,,
+356,DynamicBind,1qaw_1_TRP_7,0.26666666666666666,0.8933333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
+357,NeuralPLexer,3s6a_1_ANP_0,0.23076923076923067,0.9076923076923077,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+358,NeuralPLexer,2gf3_2_FOA_1,0.625,0.75,"{'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+359,NeuralPLexer,1v2g_1_OCA_0,0.33333333333333326,0.8666666666666667,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+360,NeuralPLexer,2r4e_1_13P_0,0.7000000000000001,0.72,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+361,NeuralPLexer,3ub7_1_ACM_1,0.4285714285714285,0.8285714285714286,"{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+362,NeuralPLexer,4cdn_2_FAD_0,0.4615384615384615,0.8153846153846154,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+363,NeuralPLexer,6yaq_1_OHZ_0,0.7857142857142859,0.6857142857142856,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+364,NeuralPLexer,4cnl_1_CHT_1,1.5,0.4,"{'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}",{}
+365,NeuralPLexer,5k45_2_GLU_1,0.2,0.92,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+366,NeuralPLexer,2zcz_2_TRP_3,0.7777777777777779,0.6888888888888889,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+367,NeuralPLexer,5fxd_1_H7Y_1,0.7999999999999999,0.68,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+368,NeuralPLexer,5k3o_2_ASP_0,0.4615384615384615,0.8153846153846154,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+369,NeuralPLexer,5fxe_1_CIY_1,0.3333333333333333,0.8666666666666667,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+370,NeuralPLexer,5ida_1_BMA_0,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+371,NeuralPLexer,4osy_1_GLY_3,,0.0,,
+372,NeuralPLexer,5k62_1_ASN-VAL_0,,0.0,,
+373,NeuralPLexer,5b5s_1_BOG_0,0.14285714285714285,0.9428571428571428,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+374,NeuralPLexer,1tke_1_SER_0,0.5,0.8,"{'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+375,NeuralPLexer,6paa_1_ASP_2,0.2500000000000001,0.8999999999999999,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+376,NeuralPLexer,2gag_1_NAD_0,0.3103448275862067,0.8758620689655173,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 7, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+377,NeuralPLexer,6o6y_1_ACK_0,0.6875,0.725,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+378,NeuralPLexer,3zec_1_ANP_0,0.5,0.8,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+379,NeuralPLexer,5mh1_1_BMA_0,,0.0,,
+380,NeuralPLexer,5dnc_1_ASN_2,,0.0,,
+381,NeuralPLexer,5u82_2_ZN0_0,,0.0,,
+382,NeuralPLexer,3wrb_1_GDE_0,0.4999999999999999,0.8,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+383,NeuralPLexer,6ep5_1_ADP_1,0.5263157894736843,0.7894736842105263,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+384,NeuralPLexer,2vfu_1_MTL_0,0.1333333333333333,0.9466666666666667,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+385,NeuralPLexer,3zzs_1_TRP_3,,0.0,,
+386,NeuralPLexer,6ryz_1_SAM_2,0.04999999999999993,0.98,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+387,NeuralPLexer,5hmr_1_FDZ_0,0.7000000000000001,0.72,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+388,NeuralPLexer,2hs3_1_FGR_0,0.2666666666666667,0.8933333333333333,"{'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+389,NeuralPLexer,6etf_1_AMP_0,,0.0,,
+390,NeuralPLexer,3jqm_1_GTP_5,0.625,0.75,"{'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+391,NeuralPLexer,3eca_1_ASP_3,0.42857142857142855,0.8285714285714285,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+392,NeuralPLexer,4osx_1_GLY_2,,0.0,,
+393,NeuralPLexer,2ze9_1_PD7_0,0.25,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+394,NeuralPLexer,5f52_1_ASP_2,,0.0,,
+395,NeuralPLexer,6xug_1_O1Q_0,,0.0,,
+396,NeuralPLexer,4fyv_1_DCP_2,0.3846153846153846,0.8461538461538461,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+397,NeuralPLexer,2hk9_1_SKM_0,0.09090909090909094,0.9636363636363636,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+398,NeuralPLexer,6v2a_1_ASN_3,,0.0,,
+399,NeuralPLexer,1rqp_1_SAM_0,0.39130434782608703,0.8434782608695652,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+400,NeuralPLexer,2wr8_1_SAH_1,0.4375,0.825,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+401,NeuralPLexer,5gqi_1_ATP_7,0.25,0.9,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+402,NeuralPLexer,2vdf_1_OCT_0,1.0,0.6,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1}",{}
+403,NeuralPLexer,4qa8_1_PJZ_0,1.3333333333333333,0.4666666666666667,"{'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+404,NeuralPLexer,5k66_1_ASN-GLU_0,,0.0,,
+405,NeuralPLexer,3gf4_1_FAD_1,0.3103448275862068,0.8758620689655173,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+406,NeuralPLexer,4tvd_1_BGC_4,0.6000000000000001,0.76,"{'UNL:GLU:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:GLU:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+407,NeuralPLexer,1u8u_1_OCA_0,0.38461538461538464,0.8461538461538461,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+408,NeuralPLexer,2xta_1_ACO_0,0.7222222222222222,0.7111111111111111,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+409,NeuralPLexer,5hhz_1_ZME_0,1.0,0.6,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2}"
+410,NeuralPLexer,4xdr_1_ADN_0,,0.0,,
+411,NeuralPLexer,6uqy_2_AT3_0,0.3076923076923077,0.8769230769230769,"{'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+412,NeuralPLexer,5k4h_2_GLU_3,0.09090909090909094,0.9636363636363636,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+413,NeuralPLexer,4tvd_1_GLC_0,0.8333333333333334,0.6666666666666666,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LYS:VdWContact': 2}"
+414,NeuralPLexer,1pj2_1_FUM_0,,0.0,,
+415,NeuralPLexer,6o70_1_ACK_1,0.09090909090909094,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+416,NeuralPLexer,2zd0_1_TRP_9,0.4615384615384614,0.8153846153846154,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+417,NeuralPLexer,1uf5_1_CDT_0,0.4285714285714287,0.8285714285714285,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+418,NeuralPLexer,4o95_1_245_0,1.1428571428571428,0.5428571428571429,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}",{'UNL:ASP:VdWContact': 1}
+419,NeuralPLexer,3ad9_1_NAD_0,0.3333333333333334,0.8666666666666667,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+420,NeuralPLexer,5k63_1_ASN-GLY_0,,0.0,,
+421,NeuralPLexer,4rpm_1_HXC_0,,0.0,,
+422,NeuralPLexer,4pfx_1_UDP_0,0.19047619047619035,0.9238095238095239,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+423,NeuralPLexer,2gah_1_NAD_0,0.1428571428571429,0.9428571428571428,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+424,NeuralPLexer,6pa2_1_ASP_2,,0.0,,
+425,NeuralPLexer,4h2f_1_ADN_0,0.375,0.85,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+426,NeuralPLexer,4u63_1_FAD_0,0.3999999999999999,0.8400000000000001,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+427,NeuralPLexer,4o0f_1_GLY_3,,0.0,,
+428,NeuralPLexer,2q6k_1_ADN_1,0.4545454545454545,0.8181818181818182,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+429,NeuralPLexer,5fiu_1_Y3J_3,0.3333333333333334,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+430,NeuralPLexer,5f2t_1_PLM_0,1.4117647058823528,0.43529411764705883,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+431,NeuralPLexer,3ada_1_NAD_0,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+432,NeuralPLexer,4b4v_1_L34_0,0.23529411764705882,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+433,NeuralPLexer,4uoc_1_NCN_1,0.4,0.84,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+434,NeuralPLexer,3uni_1_SAL_0,,0.0,,
+435,NeuralPLexer,3o7j_1_2AL_0,0.25,0.9,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+436,NeuralPLexer,2v7v_1_5FD_0,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+437,NeuralPLexer,4rhe_1_FMN_6,0.33333333333333326,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+438,NeuralPLexer,5fxf_1_BEZ_0,0.4285714285714286,0.8285714285714285,"{'UNL:ASP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+439,NeuralPLexer,2wwc_1_CHT_2,1.5,0.4,"{'UNL:GLY:VdWContact': 1, 'UNL:TYR:VdWContact': 2}",{}
+440,NeuralPLexer,6qkr_1_FAD_0,0.3,0.88,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 6, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+441,NeuralPLexer,3inr_1_GDU_0,0.5000000000000001,0.7999999999999999,"{'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 4}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+442,NeuralPLexer,4idk_1_1FE_0,0.5714285714285715,0.7714285714285714,"{'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 2}"
+443,NeuralPLexer,6yao_1_OJ2_0,0.7999999999999999,0.68,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+444,NeuralPLexer,6ea9_1_9BG_0,0.3888888888888889,0.8444444444444444,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+445,NeuralPLexer,6ur1_2_AT3_0,0.75,0.7,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+446,NeuralPLexer,4mig_1_G3F_2,,0.0,,
+447,NeuralPLexer,6wyz_1_DGL_1,1.375,0.44999999999999996,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+448,NeuralPLexer,2v7t_1_SAH_4,0.29166666666666674,0.8833333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+449,NeuralPLexer,3ad7_1_NAD_0,0.47619047619047616,0.8095238095238095,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 5, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 4, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+450,NeuralPLexer,5hw0_1_GLU_2,0.6666666666666666,0.7333333333333334,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+451,NeuralPLexer,5hqx_1_EDZ_0,0.6923076923076923,0.7230769230769231,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+452,NeuralPLexer,2q37_1_3AL_0,0.36363636363636376,0.8545454545454545,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+453,NeuralPLexer,6n19_2_K8V_0,,0.0,,
+454,NeuralPLexer,2v7w_1_5FD_0,0.40909090909090906,0.8363636363636364,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+455,NeuralPLexer,4phs_1_UDP_0,0.23529411764705876,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+456,NeuralPLexer,4ydx_1_TCE_0,0.75,0.7,"{'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}"
+457,NeuralPLexer,4xfm_1_THE_0,0.33333333333333326,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+458,NeuralPLexer,3ub9_1_NHY_1,0.8333333333333333,0.6666666666666667,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 2}"
+459,NeuralPLexer,1tkg_1_SSA_0,0.7,0.72,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+460,NeuralPLexer,4o0d_1_GLY_3,,0.0,,
+461,NeuralPLexer,6yap_1_OHZ_0,0.5882352941176471,0.7647058823529411,"{'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+462,NeuralPLexer,6xb3_3_9BG_1,0.5217391304347828,0.7913043478260868,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+463,NeuralPLexer,4kgx_1_CTP_5,0.17647058823529416,0.9294117647058824,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+464,NeuralPLexer,3se5_1_ANP_2,0.1333333333333333,0.9466666666666667,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+465,NeuralPLexer,6gbf_1_AMP_0,,0.0,,
+466,NeuralPLexer,2v7u_1_SAM_2,0.4583333333333334,0.8166666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+467,NeuralPLexer,2gag_1_FOA_0,0.4166666666666667,0.8333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+468,NeuralPLexer,4uuw_1_AMP_0,0.22222222222222227,0.9111111111111111,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+469,NeuralPLexer,4phr_1_UDP_0,0.16666666666666669,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+470,NeuralPLexer,1o72_2_PC_0,1.0,0.6,"{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+471,NeuralPLexer,4oal_2_245_0,0.7777777777777779,0.6888888888888889,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1}"
+472,NeuralPLexer,1hg0_1_SIN_1,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+473,NeuralPLexer,3zjx_1_BOG_0,0.33333333333333337,0.8666666666666667,"{'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2}","{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+474,NeuralPLexer,6pa6_2_ASN_0,,0.0,,
+475,NeuralPLexer,1qaw_1_TRP_7,0.6666666666666667,0.7333333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
+476,RFAA,3s6a_1_ANP_0,,0.0,,
+477,RFAA,2gf3_2_FOA_1,,0.0,,
+478,RFAA,1v2g_1_OCA_0,0.16666666666666663,0.9333333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+479,RFAA,2r4e_1_13P_0,,0.0,,
+480,RFAA,3ub7_1_ACM_1,0.42857142857142855,0.8285714285714285,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+481,RFAA,4cdn_2_FAD_0,,0.0,,
+482,RFAA,6yaq_1_OHZ_0,,0.0,,
+483,RFAA,4cnl_1_CHT_1,1.5714285714285714,0.37142857142857144,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:TYR:VdWContact': 3}",{}
+484,RFAA,5k45_2_GLU_1,,0.0,,
+485,RFAA,2zcz_2_TRP_3,,0.0,,
+486,RFAA,5fxd_1_H7Y_1,0.5,0.8,"{'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+487,RFAA,5k3o_2_ASP_0,,0.0,,
+488,RFAA,5fxe_1_CIY_1,,0.0,,
+489,RFAA,5ida_1_BMA_0,,0.0,,
+490,RFAA,4osy_1_GLY_3,,0.0,,
+491,RFAA,5k62_1_ASN-VAL_0,,0.0,,
+492,RFAA,5b5s_1_BOG_0,,0.0,,
+493,RFAA,1tke_1_SER_0,,0.0,,
+494,RFAA,6paa_1_ASP_2,,0.0,,
+495,RFAA,2gag_1_NAD_0,,0.0,,
+496,RFAA,6o6y_1_ACK_0,,0.0,,
+497,RFAA,3zec_1_ANP_0,,0.0,,
+498,RFAA,5mh1_1_BMA_0,,0.0,,
+499,RFAA,5dnc_1_ASN_2,,0.0,,
+500,RFAA,5u82_2_ZN0_0,,0.0,,
+501,RFAA,3wrb_1_GDE_0,,0.0,,
+502,RFAA,6ep5_1_ADP_1,,0.0,,
+503,RFAA,2vfu_1_MTL_0,,0.0,,
+504,RFAA,3zzs_1_TRP_3,,0.0,,
+505,RFAA,6ryz_1_SAM_2,,0.0,,
+506,RFAA,5hmr_1_FDZ_0,,0.0,,
+507,RFAA,2hs3_1_FGR_0,0.1428571428571429,0.9428571428571428,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+508,RFAA,6etf_1_AMP_0,,0.0,,
+509,RFAA,3jqm_1_GTP_5,,0.0,,
+510,RFAA,3eca_1_ASP_3,,0.0,,
+511,RFAA,4osx_1_GLY_2,,0.0,,
+512,RFAA,2ze9_1_PD7_0,,0.0,,
+513,RFAA,5f52_1_ASP_2,,0.0,,
+514,RFAA,6xug_1_O1Q_0,,0.0,,
+515,RFAA,4fyv_1_DCP_2,0.6000000000000001,0.76,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+516,RFAA,2hk9_1_SKM_0,,0.0,,
+517,RFAA,6v2a_1_ASN_3,,0.0,,
+518,RFAA,1rqp_1_SAM_0,,0.0,,
+519,RFAA,2wr8_1_SAH_1,,0.0,,
+520,RFAA,5gqi_1_ATP_7,0.7647058823529413,0.6941176470588235,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+521,RFAA,2vdf_1_OCT_0,,0.0,,
+522,RFAA,4qa8_1_PJZ_0,,0.0,,
+523,RFAA,5k66_1_ASN-GLU_0,,0.0,,
+524,RFAA,3gf4_1_FAD_1,0.2,0.92,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+525,RFAA,4tvd_1_BGC_4,,0.0,,
+526,RFAA,1u8u_1_OCA_0,0.3571428571428571,0.8571428571428572,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+527,RFAA,2xta_1_ACO_0,,0.0,,
+528,RFAA,5hhz_1_ZME_0,,0.0,,
+529,RFAA,4xdr_1_ADN_0,,0.0,,
+530,RFAA,6uqy_2_AT3_0,,0.0,,
+531,RFAA,5k4h_2_GLU_3,,0.0,,
+532,RFAA,4tvd_1_GLC_0,,0.0,,
+533,RFAA,1pj2_1_FUM_0,,0.0,,
+534,RFAA,6o70_1_ACK_1,,0.0,,
+535,RFAA,2zd0_1_TRP_9,,0.0,,
+536,RFAA,1uf5_1_CDT_0,,0.0,,
+537,RFAA,4o95_1_245_0,,0.0,,
+538,RFAA,3ad9_1_NAD_0,,0.0,,
+539,RFAA,5k63_1_ASN-GLY_0,,0.0,,
+540,RFAA,4rpm_1_HXC_0,,0.0,,
+541,RFAA,4pfx_1_UDP_0,0.5882352941176471,0.7647058823529411,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+542,RFAA,2gah_1_NAD_0,,0.0,,
+543,RFAA,6pa2_1_ASP_2,,0.0,,
+544,RFAA,4h2f_1_ADN_0,,0.0,,
+545,RFAA,4u63_1_FAD_0,,0.0,,
+546,RFAA,4o0f_1_GLY_3,,0.0,,
+547,RFAA,2q6k_1_ADN_1,,0.0,,
+548,RFAA,5fiu_1_Y3J_3,,0.0,,
+549,RFAA,5f2t_1_PLM_0,,0.0,,
+550,RFAA,3ada_1_NAD_0,,0.0,,
+551,RFAA,4b4v_1_L34_0,,0.0,,
+552,RFAA,4uoc_1_NCN_1,,0.0,,
+553,RFAA,3uni_1_SAL_0,,0.0,,
+554,RFAA,3o7j_1_2AL_0,0.23076923076923078,0.9076923076923077,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+555,RFAA,2v7v_1_5FD_0,,0.0,,
+556,RFAA,4rhe_1_FMN_6,,0.0,,
+557,RFAA,5fxf_1_BEZ_0,,0.0,,
+558,RFAA,2wwc_1_CHT_2,,0.0,,
+559,RFAA,6qkr_1_FAD_0,,0.0,,
+560,RFAA,3inr_1_GDU_0,,0.0,,
+561,RFAA,4idk_1_1FE_0,,0.0,,
+562,RFAA,6yao_1_OJ2_0,,0.0,,
+563,RFAA,6ea9_1_9BG_0,,0.0,,
+564,RFAA,6ur1_2_AT3_0,0.5999999999999999,0.76,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+565,RFAA,4mig_1_G3F_2,,0.0,,
+566,RFAA,6wyz_1_DGL_1,,0.0,,
+567,RFAA,2v7t_1_SAH_4,,0.0,,
+568,RFAA,3ad7_1_NAD_0,,0.0,,
+569,RFAA,5hw0_1_GLU_2,,0.0,,
+570,RFAA,5hqx_1_EDZ_0,0.5,0.8,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+571,RFAA,2q37_1_3AL_0,,0.0,,
+572,RFAA,6n19_2_K8V_0,,0.0,,
+573,RFAA,2v7w_1_5FD_0,,0.0,,
+574,RFAA,4phs_1_UDP_0,0.4375,0.825,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+575,RFAA,4ydx_1_TCE_0,,0.0,,
+576,RFAA,4xfm_1_THE_0,,0.0,,
+577,RFAA,3ub9_1_NHY_1,,0.0,,
+578,RFAA,1tkg_1_SSA_0,0.4285714285714286,0.8285714285714285,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+579,RFAA,4o0d_1_GLY_3,,0.0,,
+580,RFAA,6yap_1_OHZ_0,0.16666666666666674,0.9333333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+581,RFAA,6xb3_3_9BG_1,,0.0,,
+582,RFAA,4kgx_1_CTP_5,0.25000000000000006,0.9,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+583,RFAA,3se5_1_ANP_2,,0.0,,
+584,RFAA,6gbf_1_AMP_0,,0.0,,
+585,RFAA,2v7u_1_SAM_2,0.24999999999999992,0.9,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+586,RFAA,2gag_1_FOA_0,,0.0,,
+587,RFAA,4uuw_1_AMP_0,,0.0,,
+588,RFAA,4phr_1_UDP_0,,0.0,,
+589,RFAA,1o72_2_PC_0,,0.0,,
+590,RFAA,4oal_2_245_0,,0.0,,
+591,RFAA,1hg0_1_SIN_1,,0.0,,
+592,RFAA,3zjx_1_BOG_0,,0.0,,
+593,RFAA,6pa6_2_ASN_0,,0.0,,
+594,RFAA,1qaw_1_TRP_7,,0.0,,
+595,Chai-1-Single-Seq,3s6a_1_ANP_0,0.39999999999999997,0.8400000000000001,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+596,Chai-1-Single-Seq,2gf3_2_FOA_1,0.7000000000000001,0.72,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:GLN:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+597,Chai-1-Single-Seq,1v2g_1_OCA_0,0.6470588235294118,0.7411764705882353,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+598,Chai-1-Single-Seq,2r4e_1_13P_0,0.7999999999999999,0.68,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+599,Chai-1-Single-Seq,3ub7_1_ACM_1,1.2000000000000002,0.5199999999999999,{'UNL:TYR:VdWContact': 1},"{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+600,Chai-1-Single-Seq,4cdn_2_FAD_0,0.48000000000000004,0.808,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+601,Chai-1-Single-Seq,6yaq_1_OHZ_0,0.9333333333333333,0.6266666666666667,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+602,Chai-1-Single-Seq,4cnl_1_CHT_1,1.0,0.6,{'UNL:MET:VdWContact': 1},{}
+603,Chai-1-Single-Seq,5k45_2_GLU_1,0.5714285714285714,0.7714285714285715,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+604,Chai-1-Single-Seq,2zcz_2_TRP_3,0.33333333333333326,0.8666666666666667,"{'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+605,Chai-1-Single-Seq,5fxd_1_H7Y_1,1.25,0.5,{},"{'UNL:ASP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+606,Chai-1-Single-Seq,5k3o_2_ASP_0,0.5384615384615384,0.7846153846153846,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+607,Chai-1-Single-Seq,5fxe_1_CIY_1,1.2,0.52,{},"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+608,Chai-1-Single-Seq,5ida_1_BMA_0,0.375,0.85,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+609,Chai-1-Single-Seq,4osy_1_GLY_3,,0.0,,
+610,Chai-1-Single-Seq,5k62_1_ASN-VAL_0,,0.0,,
+611,Chai-1-Single-Seq,5b5s_1_BOG_0,1.0,0.6,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+612,Chai-1-Single-Seq,1tke_1_SER_0,0.6000000000000001,0.76,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+613,Chai-1-Single-Seq,6paa_1_ASP_2,,0.0,,
+614,Chai-1-Single-Seq,2gag_1_NAD_0,0.6086956521739131,0.7565217391304347,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+615,Chai-1-Single-Seq,6o6y_1_ACK_0,0.6875,0.725,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+616,Chai-1-Single-Seq,3zec_1_ANP_0,0.4666666666666668,0.8133333333333332,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+617,Chai-1-Single-Seq,5mh1_1_BMA_0,,0.0,,
+618,Chai-1-Single-Seq,5dnc_1_ASN_2,,0.0,,
+619,Chai-1-Single-Seq,5u82_2_ZN0_0,,0.0,,
+620,Chai-1-Single-Seq,3wrb_1_GDE_0,0.8571428571428571,0.6571428571428571,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+621,Chai-1-Single-Seq,6ep5_1_ADP_1,0.35294117647058826,0.8588235294117648,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+622,Chai-1-Single-Seq,2vfu_1_MTL_0,0.23076923076923078,0.9076923076923077,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+623,Chai-1-Single-Seq,3zzs_1_TRP_3,,0.0,,
+624,Chai-1-Single-Seq,6ryz_1_SAM_2,0.08000000000000002,0.968,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+625,Chai-1-Single-Seq,5hmr_1_FDZ_0,0.7,0.72,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+626,Chai-1-Single-Seq,2hs3_1_FGR_0,0.13333333333333333,0.9466666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+627,Chai-1-Single-Seq,6etf_1_AMP_0,,0.0,,
+628,Chai-1-Single-Seq,3jqm_1_GTP_5,1.0,0.6,{},"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+629,Chai-1-Single-Seq,3eca_1_ASP_3,0.18181818181818188,0.9272727272727272,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+630,Chai-1-Single-Seq,4osx_1_GLY_2,,0.0,,
+631,Chai-1-Single-Seq,2ze9_1_PD7_0,0.75,0.7,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+632,Chai-1-Single-Seq,5f52_1_ASP_2,,0.0,,
+633,Chai-1-Single-Seq,6xug_1_O1Q_0,,0.0,,
+634,Chai-1-Single-Seq,4fyv_1_DCP_2,0.5833333333333333,0.7666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+635,Chai-1-Single-Seq,2hk9_1_SKM_0,0.6428571428571429,0.7428571428571429,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+636,Chai-1-Single-Seq,6v2a_1_ASN_3,,0.0,,
+637,Chai-1-Single-Seq,1rqp_1_SAM_0,0.15000000000000008,0.94,"{'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+638,Chai-1-Single-Seq,2wr8_1_SAH_1,0.4375,0.825,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+639,Chai-1-Single-Seq,5gqi_1_ATP_7,0.0,1.0,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+640,Chai-1-Single-Seq,2vdf_1_OCT_0,1.0,0.6,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}",{}
+641,Chai-1-Single-Seq,4qa8_1_PJZ_0,1.7058823529411766,0.3176470588235294,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 6, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+642,Chai-1-Single-Seq,5k66_1_ASN-GLU_0,,0.0,,
+643,Chai-1-Single-Seq,3gf4_1_FAD_1,0.2592592592592592,0.8962962962962964,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+644,Chai-1-Single-Seq,4tvd_1_BGC_4,,0.0,,
+645,Chai-1-Single-Seq,1u8u_1_OCA_0,0.7368421052631579,0.7052631578947368,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+646,Chai-1-Single-Seq,2xta_1_ACO_0,0.4615384615384615,0.8153846153846154,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+647,Chai-1-Single-Seq,5hhz_1_ZME_0,1.0,0.6,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2}"
+648,Chai-1-Single-Seq,4xdr_1_ADN_0,,0.0,,
+649,Chai-1-Single-Seq,6uqy_2_AT3_0,0.18181818181818185,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+650,Chai-1-Single-Seq,5k4h_2_GLU_3,0.1428571428571429,0.9428571428571428,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+651,Chai-1-Single-Seq,4tvd_1_GLC_0,,0.0,,
+652,Chai-1-Single-Seq,1pj2_1_FUM_0,0.6666666666666667,0.7333333333333333,"{'UNL:ARG:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2}"
+653,Chai-1-Single-Seq,6o70_1_ACK_1,0.411764705882353,0.8352941176470587,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+654,Chai-1-Single-Seq,2zd0_1_TRP_9,0.22222222222222227,0.9111111111111111,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+655,Chai-1-Single-Seq,1uf5_1_CDT_0,0.4,0.84,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+656,Chai-1-Single-Seq,4o95_1_245_0,1.1,0.5599999999999999,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}",{'UNL:ASP:VdWContact': 1}
+657,Chai-1-Single-Seq,3ad9_1_NAD_0,0.4545454545454546,0.8181818181818181,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 5, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+658,Chai-1-Single-Seq,5k63_1_ASN-GLY_0,,0.0,,
+659,Chai-1-Single-Seq,4rpm_1_HXC_0,,0.0,,
+660,Chai-1-Single-Seq,4pfx_1_UDP_0,,0.0,,
+661,Chai-1-Single-Seq,2gah_1_NAD_0,0.49999999999999994,0.8,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+662,Chai-1-Single-Seq,6pa2_1_ASP_2,,0.0,,
+663,Chai-1-Single-Seq,4h2f_1_ADN_0,0.29999999999999993,0.88,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+664,Chai-1-Single-Seq,4u63_1_FAD_0,0.5862068965517241,0.7655172413793103,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+665,Chai-1-Single-Seq,4o0f_1_GLY_3,,0.0,,
+666,Chai-1-Single-Seq,2q6k_1_ADN_1,0.11764705882352944,0.9529411764705882,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+667,Chai-1-Single-Seq,5fiu_1_Y3J_3,0.25,0.9,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+668,Chai-1-Single-Seq,5f2t_1_PLM_0,1.375,0.44999999999999996,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+669,Chai-1-Single-Seq,3ada_1_NAD_0,0.5217391304347827,0.7913043478260869,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 5, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+670,Chai-1-Single-Seq,4b4v_1_L34_0,0.375,0.85,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+671,Chai-1-Single-Seq,4uoc_1_NCN_1,0.30434782608695654,0.8782608695652174,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+672,Chai-1-Single-Seq,3uni_1_SAL_0,,0.0,,
+673,Chai-1-Single-Seq,3o7j_1_2AL_0,0.49999999999999994,0.8,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+674,Chai-1-Single-Seq,2v7v_1_5FD_0,0.4347826086956521,0.8260869565217391,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+675,Chai-1-Single-Seq,4rhe_1_FMN_6,0.875,0.65,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+676,Chai-1-Single-Seq,5fxf_1_BEZ_0,0.25,0.9,"{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+677,Chai-1-Single-Seq,2wwc_1_CHT_2,1.3333333333333335,0.46666666666666656,"{'UNL:GLY:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}",{}
+678,Chai-1-Single-Seq,6qkr_1_FAD_0,0.4146341463414634,0.8341463414634147,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+679,Chai-1-Single-Seq,3inr_1_GDU_0,0.6111111111111112,0.7555555555555555,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+680,Chai-1-Single-Seq,4idk_1_1FE_0,0.5,0.8,"{'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 2}"
+681,Chai-1-Single-Seq,6yao_1_OJ2_0,1.0,0.6,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+682,Chai-1-Single-Seq,6ea9_1_9BG_0,0.5714285714285713,0.7714285714285715,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+683,Chai-1-Single-Seq,6ur1_2_AT3_0,0.8333333333333334,0.6666666666666666,"{'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+684,Chai-1-Single-Seq,4mig_1_G3F_2,0.8,0.6799999999999999,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+685,Chai-1-Single-Seq,6wyz_1_DGL_1,0.5833333333333334,0.7666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+686,Chai-1-Single-Seq,2v7t_1_SAH_4,0.4210526315789474,0.831578947368421,"{'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+687,Chai-1-Single-Seq,3ad7_1_NAD_0,0.4761904761904761,0.8095238095238095,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+688,Chai-1-Single-Seq,5hw0_1_GLU_2,0.8,0.6799999999999999,"{'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+689,Chai-1-Single-Seq,5hqx_1_EDZ_0,0.3333333333333334,0.8666666666666667,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+690,Chai-1-Single-Seq,2q37_1_3AL_0,0.36363636363636365,0.8545454545454545,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+691,Chai-1-Single-Seq,6n19_2_K8V_0,,0.0,,
+692,Chai-1-Single-Seq,2v7w_1_5FD_0,0.2631578947368421,0.8947368421052632,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+693,Chai-1-Single-Seq,4phs_1_UDP_0,0.3529411764705882,0.8588235294117648,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+694,Chai-1-Single-Seq,4ydx_1_TCE_0,0.33333333333333337,0.8666666666666667,"{'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}"
+695,Chai-1-Single-Seq,4xfm_1_THE_0,0.375,0.85,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+696,Chai-1-Single-Seq,3ub9_1_NHY_1,0.5,0.8,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 2}"
+697,Chai-1-Single-Seq,1tkg_1_SSA_0,0.3076923076923077,0.8769230769230769,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+698,Chai-1-Single-Seq,4o0d_1_GLY_3,,0.0,,
+699,Chai-1-Single-Seq,6yap_1_OHZ_0,0.5833333333333334,0.7666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+700,Chai-1-Single-Seq,6xb3_3_9BG_1,0.40000000000000013,0.84,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+701,Chai-1-Single-Seq,4kgx_1_CTP_5,0.23076923076923078,0.9076923076923077,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+702,Chai-1-Single-Seq,3se5_1_ANP_2,0.38888888888888895,0.8444444444444444,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+703,Chai-1-Single-Seq,6gbf_1_AMP_0,,0.0,,
+704,Chai-1-Single-Seq,2v7u_1_SAM_2,0.3333333333333333,0.8666666666666667,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+705,Chai-1-Single-Seq,2gag_1_FOA_0,0.36363636363636365,0.8545454545454545,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+706,Chai-1-Single-Seq,4uuw_1_AMP_0,0.7142857142857144,0.7142857142857142,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+707,Chai-1-Single-Seq,4phr_1_UDP_0,0.4444444444444445,0.8222222222222222,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+708,Chai-1-Single-Seq,1o72_2_PC_0,0.25,0.9,"{'UNL:ARG:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+709,Chai-1-Single-Seq,4oal_2_245_0,0.8888888888888891,0.6444444444444444,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1}"
+710,Chai-1-Single-Seq,1hg0_1_SIN_1,0.5454545454545454,0.7818181818181819,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+711,Chai-1-Single-Seq,3zjx_1_BOG_0,0.8,0.6799999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+712,Chai-1-Single-Seq,6pa6_2_ASN_0,,0.0,,
+713,Chai-1-Single-Seq,1qaw_1_TRP_7,0.4285714285714285,0.8285714285714286,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
+714,Chai-1,3s6a_1_ANP_0,0.38461538461538464,0.8461538461538461,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+715,Chai-1,2gf3_2_FOA_1,,0.0,,
+716,Chai-1,1v2g_1_OCA_0,0.6666666666666667,0.7333333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+717,Chai-1,2r4e_1_13P_0,0.3333333333333333,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+718,Chai-1,3ub7_1_ACM_1,,0.0,,
+719,Chai-1,4cdn_2_FAD_0,0.5200000000000001,0.7919999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+720,Chai-1,6yaq_1_OHZ_0,0.8125,0.675,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+721,Chai-1,4cnl_1_CHT_1,1.3333333333333335,0.46666666666666656,"{'UNL:MET:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}",{}
+722,Chai-1,5k45_2_GLU_1,0.5714285714285714,0.7714285714285715,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+723,Chai-1,2zcz_2_TRP_3,0.4375,0.825,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+724,Chai-1,5fxd_1_H7Y_1,1.25,0.5,{},"{'UNL:ASP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+725,Chai-1,5k3o_2_ASP_0,0.49999999999999994,0.8,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+726,Chai-1,5fxe_1_CIY_1,1.2,0.52,{},"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+727,Chai-1,5ida_1_BMA_0,0.375,0.85,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+728,Chai-1,4osy_1_GLY_3,,0.0,,
+729,Chai-1,5k62_1_ASN-VAL_0,,0.0,,
+730,Chai-1,5b5s_1_BOG_0,0.625,0.75,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+731,Chai-1,1tke_1_SER_0,0.5454545454545454,0.7818181818181819,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+732,Chai-1,6paa_1_ASP_2,0.33333333333333326,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+733,Chai-1,2gag_1_NAD_0,0.17391304347826086,0.9304347826086956,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+734,Chai-1,6o6y_1_ACK_0,0.9090909090909091,0.6363636363636364,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+735,Chai-1,3zec_1_ANP_0,,0.0,,
+736,Chai-1,5mh1_1_BMA_0,,0.0,,
+737,Chai-1,5dnc_1_ASN_2,,0.0,,
+738,Chai-1,5u82_2_ZN0_0,,0.0,,
+739,Chai-1,3wrb_1_GDE_0,0.7142857142857142,0.7142857142857143,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+740,Chai-1,6ep5_1_ADP_1,,0.0,,
+741,Chai-1,2vfu_1_MTL_0,0.1538461538461539,0.9384615384615385,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+742,Chai-1,3zzs_1_TRP_3,,0.0,,
+743,Chai-1,6ryz_1_SAM_2,,0.0,,
+744,Chai-1,5hmr_1_FDZ_0,0.7999999999999999,0.68,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+745,Chai-1,2hs3_1_FGR_0,,0.0,,
+746,Chai-1,6etf_1_AMP_0,,0.0,,
+747,Chai-1,3jqm_1_GTP_5,,0.0,,
+748,Chai-1,3eca_1_ASP_3,1.5,0.4,{},"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+749,Chai-1,4osx_1_GLY_2,,0.0,,
+750,Chai-1,2ze9_1_PD7_0,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+751,Chai-1,5f52_1_ASP_2,,0.0,,
+752,Chai-1,6xug_1_O1Q_0,,0.0,,
+753,Chai-1,4fyv_1_DCP_2,0.35714285714285715,0.8571428571428572,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+754,Chai-1,2hk9_1_SKM_0,0.5,0.8,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+755,Chai-1,6v2a_1_ASN_3,,0.0,,
+756,Chai-1,1rqp_1_SAM_0,0.11111111111111116,0.9555555555555555,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+757,Chai-1,2wr8_1_SAH_1,0.2857142857142857,0.8857142857142857,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+758,Chai-1,5gqi_1_ATP_7,0.4,0.84,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+759,Chai-1,2vdf_1_OCT_0,1.4,0.44000000000000006,"{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}",{}
+760,Chai-1,4qa8_1_PJZ_0,1.4705882352941178,0.4117647058823529,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 6, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+761,Chai-1,5k66_1_ASN-GLU_0,,0.0,,
+762,Chai-1,3gf4_1_FAD_1,0.37037037037037046,0.8518518518518519,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+763,Chai-1,4tvd_1_BGC_4,0.6666666666666667,0.7333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:GLU:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+764,Chai-1,1u8u_1_OCA_0,0.4117647058823529,0.8352941176470589,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+765,Chai-1,2xta_1_ACO_0,0.33333333333333337,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+766,Chai-1,5hhz_1_ZME_0,0.875,0.65,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2}"
+767,Chai-1,4xdr_1_ADN_0,,0.0,,
+768,Chai-1,6uqy_2_AT3_0,,0.0,,
+769,Chai-1,5k4h_2_GLU_3,,0.0,,
+770,Chai-1,4tvd_1_GLC_0,,0.0,,
+771,Chai-1,1pj2_1_FUM_0,0.5999999999999999,0.76,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2}"
+772,Chai-1,6o70_1_ACK_1,0.5263157894736843,0.7894736842105263,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+773,Chai-1,2zd0_1_TRP_9,0.47058823529411764,0.8117647058823529,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+774,Chai-1,1uf5_1_CDT_0,0.3125,0.875,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+775,Chai-1,4o95_1_245_0,1.2000000000000002,0.5199999999999999,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}",{'UNL:ASP:VdWContact': 1}
+776,Chai-1,3ad9_1_NAD_0,0.3636363636363637,0.8545454545454545,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+777,Chai-1,5k63_1_ASN-GLY_0,,0.0,,
+778,Chai-1,4rpm_1_HXC_0,,0.0,,
+779,Chai-1,4pfx_1_UDP_0,0.10526315789473678,0.9578947368421052,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+780,Chai-1,2gah_1_NAD_0,1.0588235294117647,0.5764705882352941,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+781,Chai-1,6pa2_1_ASP_2,,0.0,,
+782,Chai-1,4h2f_1_ADN_0,0.5454545454545454,0.7818181818181819,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+783,Chai-1,4u63_1_FAD_0,0.5185185185185185,0.7925925925925926,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+784,Chai-1,4o0f_1_GLY_3,,0.0,,
+785,Chai-1,2q6k_1_ADN_1,0.4166666666666666,0.8333333333333334,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+786,Chai-1,5fiu_1_Y3J_3,0.3,0.88,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+787,Chai-1,5f2t_1_PLM_0,1.2352941176470589,0.5058823529411764,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+788,Chai-1,3ada_1_NAD_0,0.4090909090909091,0.8363636363636364,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+789,Chai-1,4b4v_1_L34_0,0.45833333333333337,0.8166666666666667,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+790,Chai-1,4uoc_1_NCN_1,0.17647058823529405,0.9294117647058824,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+791,Chai-1,3uni_1_SAL_0,,0.0,,
+792,Chai-1,3o7j_1_2AL_0,0.49999999999999994,0.8,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+793,Chai-1,2v7v_1_5FD_0,0.5454545454545454,0.7818181818181819,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+794,Chai-1,4rhe_1_FMN_6,,0.0,,
+795,Chai-1,5fxf_1_BEZ_0,0.4,0.84,"{'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+796,Chai-1,2wwc_1_CHT_2,1.0,0.6,{'UNL:TRP:VdWContact': 1},{}
+797,Chai-1,6qkr_1_FAD_0,0.32258064516129026,0.8709677419354839,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+798,Chai-1,3inr_1_GDU_0,0.11764705882352944,0.9529411764705882,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+799,Chai-1,4idk_1_1FE_0,0.6666666666666666,0.7333333333333334,"{'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 2}"
+800,Chai-1,6yao_1_OJ2_0,0.8333333333333334,0.6666666666666666,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+801,Chai-1,6ea9_1_9BG_0,0.5,0.8,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+802,Chai-1,6ur1_2_AT3_0,0.9375,0.625,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+803,Chai-1,4mig_1_G3F_2,0.7272727272727273,0.7090909090909091,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+804,Chai-1,6wyz_1_DGL_1,,0.0,,
+805,Chai-1,2v7t_1_SAH_4,0.10526315789473684,0.9578947368421052,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+806,Chai-1,3ad7_1_NAD_0,0.5000000000000001,0.7999999999999999,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+807,Chai-1,5hw0_1_GLU_2,0.36363636363636365,0.8545454545454545,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+808,Chai-1,5hqx_1_EDZ_0,0.4444444444444445,0.8222222222222222,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+809,Chai-1,2q37_1_3AL_0,0.4166666666666667,0.8333333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 3, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+810,Chai-1,6n19_2_K8V_0,,0.0,,
+811,Chai-1,2v7w_1_5FD_0,0.5238095238095237,0.7904761904761906,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+812,Chai-1,4phs_1_UDP_0,0.05882352941176469,0.9764705882352941,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+813,Chai-1,4ydx_1_TCE_0,0.0,1.0,"{'UNL:CYS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}"
+814,Chai-1,4xfm_1_THE_0,0.28571428571428575,0.8857142857142857,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+815,Chai-1,3ub9_1_NHY_1,,0.0,,
+816,Chai-1,1tkg_1_SSA_0,0.7058823529411765,0.7176470588235294,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+817,Chai-1,4o0d_1_GLY_3,,0.0,,
+818,Chai-1,6yap_1_OHZ_0,0.6,0.76,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+819,Chai-1,6xb3_3_9BG_1,0.6818181818181818,0.7272727272727273,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+820,Chai-1,4kgx_1_CTP_5,0.3125,0.875,"{'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+821,Chai-1,3se5_1_ANP_2,1.6363636363636362,0.34545454545454546,{},"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+822,Chai-1,6gbf_1_AMP_0,,0.0,,
+823,Chai-1,2v7u_1_SAM_2,0.11111111111111105,0.9555555555555556,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+824,Chai-1,2gag_1_FOA_0,0.28571428571428575,0.8857142857142857,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+825,Chai-1,4uuw_1_AMP_0,0.7692307692307693,0.6923076923076923,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+826,Chai-1,4phr_1_UDP_0,0.3999999999999999,0.8400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+827,Chai-1,1o72_2_PC_0,0.5999999999999999,0.76,"{'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+828,Chai-1,4oal_2_245_0,0.9090909090909092,0.6363636363636364,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1}"
+829,Chai-1,1hg0_1_SIN_1,1.0909090909090908,0.5636363636363637,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+830,Chai-1,3zjx_1_BOG_0,0.8571428571428572,0.6571428571428571,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+831,Chai-1,6pa6_2_ASN_0,,0.0,,
+832,Chai-1,1qaw_1_TRP_7,0.9090909090909092,0.6363636363636364,"{'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
+833,Boltz-1-Single-Seq,3s6a_1_ANP_0,0.3571428571428572,0.8571428571428571,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+834,Boltz-1-Single-Seq,2gf3_2_FOA_1,1.0,0.6,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:GLN:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+835,Boltz-1-Single-Seq,1v2g_1_OCA_0,0.5714285714285714,0.7714285714285715,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+836,Boltz-1-Single-Seq,2r4e_1_13P_0,0.25,0.9,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+837,Boltz-1-Single-Seq,3ub7_1_ACM_1,0.44444444444444436,0.8222222222222222,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+838,Boltz-1-Single-Seq,4cdn_2_FAD_0,0.48000000000000004,0.808,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+839,Boltz-1-Single-Seq,6yaq_1_OHZ_0,0.85,0.66,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+840,Boltz-1-Single-Seq,4cnl_1_CHT_1,1.0,0.6,"{'UNL:GLY:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}",{}
+841,Boltz-1-Single-Seq,5k45_2_GLU_1,0.41666666666666663,0.8333333333333334,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+842,Boltz-1-Single-Seq,2zcz_2_TRP_3,0.6470588235294118,0.7411764705882353,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+843,Boltz-1-Single-Seq,5fxd_1_H7Y_1,0.6666666666666667,0.7333333333333333,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+844,Boltz-1-Single-Seq,5k3o_2_ASP_0,0.5333333333333334,0.7866666666666666,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+845,Boltz-1-Single-Seq,5fxe_1_CIY_1,0.5833333333333333,0.7666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+846,Boltz-1-Single-Seq,5ida_1_BMA_0,0.25,0.9,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+847,Boltz-1-Single-Seq,4osy_1_GLY_3,,0.0,,
+848,Boltz-1-Single-Seq,5k62_1_ASN-VAL_0,,0.0,,
+849,Boltz-1-Single-Seq,5b5s_1_BOG_0,0.4,0.84,"{'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+850,Boltz-1-Single-Seq,1tke_1_SER_0,0.5555555555555556,0.7777777777777778,"{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+851,Boltz-1-Single-Seq,6paa_1_ASP_2,0.39999999999999997,0.8400000000000001,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+852,Boltz-1-Single-Seq,2gag_1_NAD_0,,0.0,,
+853,Boltz-1-Single-Seq,6o6y_1_ACK_0,0.9285714285714286,0.6285714285714286,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+854,Boltz-1-Single-Seq,3zec_1_ANP_0,0.5,0.8,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+855,Boltz-1-Single-Seq,5mh1_1_BMA_0,,0.0,,
+856,Boltz-1-Single-Seq,5dnc_1_ASN_2,,0.0,,
+857,Boltz-1-Single-Seq,5u82_2_ZN0_0,,0.0,,
+858,Boltz-1-Single-Seq,3wrb_1_GDE_0,0.6428571428571428,0.7428571428571429,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+859,Boltz-1-Single-Seq,6ep5_1_ADP_1,0.13333333333333333,0.9466666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+860,Boltz-1-Single-Seq,2vfu_1_MTL_0,0.0,1.0,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+861,Boltz-1-Single-Seq,3zzs_1_TRP_3,,0.0,,
+862,Boltz-1-Single-Seq,6ryz_1_SAM_2,0.5599999999999999,0.776,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+863,Boltz-1-Single-Seq,5hmr_1_FDZ_0,1.0,0.6,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+864,Boltz-1-Single-Seq,2hs3_1_FGR_0,0.5555555555555556,0.7777777777777778,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+865,Boltz-1-Single-Seq,6etf_1_AMP_0,,0.0,,
+866,Boltz-1-Single-Seq,3jqm_1_GTP_5,1.0,0.6,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+867,Boltz-1-Single-Seq,3eca_1_ASP_3,0.4375,0.825,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+868,Boltz-1-Single-Seq,4osx_1_GLY_2,,0.0,,
+869,Boltz-1-Single-Seq,2ze9_1_PD7_0,0.4375,0.825,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+870,Boltz-1-Single-Seq,5f52_1_ASP_2,,0.0,,
+871,Boltz-1-Single-Seq,6xug_1_O1Q_0,,0.0,,
+872,Boltz-1-Single-Seq,4fyv_1_DCP_2,0.7692307692307692,0.6923076923076923,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+873,Boltz-1-Single-Seq,2hk9_1_SKM_0,0.4545454545454546,0.8181818181818181,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+874,Boltz-1-Single-Seq,6v2a_1_ASN_3,,0.0,,
+875,Boltz-1-Single-Seq,1rqp_1_SAM_0,0.5555555555555555,0.7777777777777778,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+876,Boltz-1-Single-Seq,2wr8_1_SAH_1,0.5,0.8,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+877,Boltz-1-Single-Seq,5gqi_1_ATP_7,,0.0,,
+878,Boltz-1-Single-Seq,2vdf_1_OCT_0,1.2857142857142856,0.48571428571428577,"{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1}",{}
+879,Boltz-1-Single-Seq,4qa8_1_PJZ_0,1.4705882352941175,0.41176470588235303,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 5, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+880,Boltz-1-Single-Seq,5k66_1_ASN-GLU_0,,0.0,,
+881,Boltz-1-Single-Seq,3gf4_1_FAD_1,0.46875,0.8125,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+882,Boltz-1-Single-Seq,4tvd_1_BGC_4,0.4,0.84,"{'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:GLU:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+883,Boltz-1-Single-Seq,1u8u_1_OCA_0,0.6875,0.725,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+884,Boltz-1-Single-Seq,2xta_1_ACO_0,,0.0,,
+885,Boltz-1-Single-Seq,5hhz_1_ZME_0,1.0909090909090908,0.5636363636363637,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2}"
+886,Boltz-1-Single-Seq,4xdr_1_ADN_0,,0.0,,
+887,Boltz-1-Single-Seq,6uqy_2_AT3_0,0.5333333333333332,0.7866666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+888,Boltz-1-Single-Seq,5k4h_2_GLU_3,0.46153846153846156,0.8153846153846154,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+889,Boltz-1-Single-Seq,4tvd_1_GLC_0,0.8,0.6799999999999999,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LYS:VdWContact': 2}"
+890,Boltz-1-Single-Seq,1pj2_1_FUM_0,,0.0,,
+891,Boltz-1-Single-Seq,6o70_1_ACK_1,,0.0,,
+892,Boltz-1-Single-Seq,2zd0_1_TRP_9,0.6470588235294118,0.7411764705882353,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+893,Boltz-1-Single-Seq,1uf5_1_CDT_0,0.23076923076923078,0.9076923076923077,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+894,Boltz-1-Single-Seq,4o95_1_245_0,1.2,0.52,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}",{'UNL:ASP:VdWContact': 1}
+895,Boltz-1-Single-Seq,3ad9_1_NAD_0,,0.0,,
+896,Boltz-1-Single-Seq,5k63_1_ASN-GLY_0,,0.0,,
+897,Boltz-1-Single-Seq,4rpm_1_HXC_0,,0.0,,
+898,Boltz-1-Single-Seq,4pfx_1_UDP_0,0.21052631578947367,0.9157894736842105,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+899,Boltz-1-Single-Seq,2gah_1_NAD_0,,0.0,,
+900,Boltz-1-Single-Seq,6pa2_1_ASP_2,,0.0,,
+901,Boltz-1-Single-Seq,4h2f_1_ADN_0,0.6666666666666666,0.7333333333333334,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+902,Boltz-1-Single-Seq,4u63_1_FAD_0,0.6206896551724137,0.7517241379310345,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+903,Boltz-1-Single-Seq,4o0f_1_GLY_3,,0.0,,
+904,Boltz-1-Single-Seq,2q6k_1_ADN_1,0.1818181818181817,0.9272727272727274,"{'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+905,Boltz-1-Single-Seq,5fiu_1_Y3J_3,0.4761904761904763,0.8095238095238095,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+906,Boltz-1-Single-Seq,5f2t_1_PLM_0,1.2000000000000002,0.5199999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+907,Boltz-1-Single-Seq,3ada_1_NAD_0,,0.0,,
+908,Boltz-1-Single-Seq,4b4v_1_L34_0,0.48000000000000004,0.808,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+909,Boltz-1-Single-Seq,4uoc_1_NCN_1,0.10526315789473689,0.9578947368421052,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+910,Boltz-1-Single-Seq,3uni_1_SAL_0,,0.0,,
+911,Boltz-1-Single-Seq,3o7j_1_2AL_0,0.5714285714285714,0.7714285714285715,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+912,Boltz-1-Single-Seq,2v7v_1_5FD_0,0.45833333333333326,0.8166666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+913,Boltz-1-Single-Seq,4rhe_1_FMN_6,0.42105263157894746,0.831578947368421,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+914,Boltz-1-Single-Seq,5fxf_1_BEZ_0,0.2,0.92,"{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+915,Boltz-1-Single-Seq,2wwc_1_CHT_2,1.6666666666666667,0.33333333333333326,"{'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 2}",{}
+916,Boltz-1-Single-Seq,6qkr_1_FAD_0,0.6,0.76,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 3, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+917,Boltz-1-Single-Seq,3inr_1_GDU_0,0.5,0.8,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 4}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+918,Boltz-1-Single-Seq,4idk_1_1FE_0,0.8666666666666667,0.6533333333333333,"{'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 2}"
+919,Boltz-1-Single-Seq,6yao_1_OJ2_0,1.0909090909090908,0.5636363636363637,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+920,Boltz-1-Single-Seq,6ea9_1_9BG_0,0.22222222222222227,0.9111111111111111,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+921,Boltz-1-Single-Seq,6ur1_2_AT3_0,0.7999999999999999,0.68,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+922,Boltz-1-Single-Seq,4mig_1_G3F_2,,0.0,,
+923,Boltz-1-Single-Seq,6wyz_1_DGL_1,0.4,0.84,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+924,Boltz-1-Single-Seq,2v7t_1_SAH_4,0.34782608695652173,0.8608695652173913,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+925,Boltz-1-Single-Seq,3ad7_1_NAD_0,,0.0,,
+926,Boltz-1-Single-Seq,5hw0_1_GLU_2,0.3,0.88,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+927,Boltz-1-Single-Seq,5hqx_1_EDZ_0,0.7692307692307692,0.6923076923076923,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+928,Boltz-1-Single-Seq,2q37_1_3AL_0,0.46153846153846145,0.8153846153846154,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+929,Boltz-1-Single-Seq,6n19_2_K8V_0,,0.0,,
+930,Boltz-1-Single-Seq,2v7w_1_5FD_0,0.5217391304347827,0.7913043478260869,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+931,Boltz-1-Single-Seq,4phs_1_UDP_0,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+932,Boltz-1-Single-Seq,4ydx_1_TCE_0,0.5,0.8,"{'UNL:CYS:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}"
+933,Boltz-1-Single-Seq,4xfm_1_THE_0,0.6,0.76,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+934,Boltz-1-Single-Seq,3ub9_1_NHY_1,0.7142857142857143,0.7142857142857143,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 2}"
+935,Boltz-1-Single-Seq,1tkg_1_SSA_0,0.5882352941176471,0.7647058823529411,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+936,Boltz-1-Single-Seq,4o0d_1_GLY_3,,0.0,,
+937,Boltz-1-Single-Seq,6yap_1_OHZ_0,0.6923076923076923,0.7230769230769231,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+938,Boltz-1-Single-Seq,6xb3_3_9BG_1,0.5454545454545454,0.7818181818181819,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+939,Boltz-1-Single-Seq,4kgx_1_CTP_5,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+940,Boltz-1-Single-Seq,3se5_1_ANP_2,0.33333333333333326,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+941,Boltz-1-Single-Seq,6gbf_1_AMP_0,,0.0,,
+942,Boltz-1-Single-Seq,2v7u_1_SAM_2,0.52,0.792,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+943,Boltz-1-Single-Seq,2gag_1_FOA_0,,0.0,,
+944,Boltz-1-Single-Seq,4uuw_1_AMP_0,0.8571428571428572,0.6571428571428571,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+945,Boltz-1-Single-Seq,4phr_1_UDP_0,0.411764705882353,0.8352941176470587,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+946,Boltz-1-Single-Seq,1o72_2_PC_0,0.7777777777777779,0.6888888888888889,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+947,Boltz-1-Single-Seq,4oal_2_245_0,1.1818181818181819,0.5272727272727272,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1}"
+948,Boltz-1-Single-Seq,1hg0_1_SIN_1,0.6363636363636364,0.7454545454545455,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+949,Boltz-1-Single-Seq,3zjx_1_BOG_0,1.0,0.6,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+950,Boltz-1-Single-Seq,6pa6_2_ASN_0,,0.0,,
+951,Boltz-1-Single-Seq,1qaw_1_TRP_7,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
+952,Boltz-1,3s6a_1_ANP_0,0.30769230769230776,0.8769230769230769,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+953,Boltz-1,2gf3_2_FOA_1,0.75,0.7,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:GLN:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+954,Boltz-1,1v2g_1_OCA_0,0.6,0.76,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+955,Boltz-1,2r4e_1_13P_0,0.3636363636363636,0.8545454545454545,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+956,Boltz-1,3ub7_1_ACM_1,0.25,0.9,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+957,Boltz-1,4cdn_2_FAD_0,0.4000000000000001,0.84,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+958,Boltz-1,6yaq_1_OHZ_0,0.7857142857142858,0.6857142857142857,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+959,Boltz-1,4cnl_1_CHT_1,1.3333333333333335,0.46666666666666656,"{'UNL:MET:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}",{}
+960,Boltz-1,5k45_2_GLU_1,0.16666666666666666,0.9333333333333333,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+961,Boltz-1,2zcz_2_TRP_3,0.625,0.75,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+962,Boltz-1,5fxd_1_H7Y_1,,0.0,,
+963,Boltz-1,5k3o_2_ASP_0,0.5333333333333334,0.7866666666666666,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+964,Boltz-1,5fxe_1_CIY_1,,0.0,,
+965,Boltz-1,5ida_1_BMA_0,0.14285714285714285,0.9428571428571428,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+966,Boltz-1,4osy_1_GLY_3,,0.0,,
+967,Boltz-1,5k62_1_ASN-VAL_0,,0.0,,
+968,Boltz-1,5b5s_1_BOG_0,0.6000000000000001,0.76,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+969,Boltz-1,1tke_1_SER_0,0.6000000000000001,0.76,"{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+970,Boltz-1,6paa_1_ASP_2,0.3571428571428571,0.8571428571428572,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+971,Boltz-1,2gag_1_NAD_0,,0.0,,
+972,Boltz-1,6o6y_1_ACK_0,0.9999999999999999,0.6000000000000001,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+973,Boltz-1,3zec_1_ANP_0,,0.0,,
+974,Boltz-1,5mh1_1_BMA_0,,0.0,,
+975,Boltz-1,5dnc_1_ASN_2,,0.0,,
+976,Boltz-1,5u82_2_ZN0_0,,0.0,,
+977,Boltz-1,3wrb_1_GDE_0,,0.0,,
+978,Boltz-1,6ep5_1_ADP_1,,0.0,,
+979,Boltz-1,2vfu_1_MTL_0,0.15384615384615385,0.9384615384615385,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+980,Boltz-1,3zzs_1_TRP_3,,0.0,,
+981,Boltz-1,6ryz_1_SAM_2,,0.0,,
+982,Boltz-1,5hmr_1_FDZ_0,1.0,0.6,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+983,Boltz-1,2hs3_1_FGR_0,0.31578947368421045,0.8736842105263158,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+984,Boltz-1,6etf_1_AMP_0,,0.0,,
+985,Boltz-1,3jqm_1_GTP_5,1.1249999999999998,0.55,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 2, 'UNL:LYS:VdWContact': 4, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+986,Boltz-1,3eca_1_ASP_3,,0.0,,
+987,Boltz-1,4osx_1_GLY_2,,0.0,,
+988,Boltz-1,2ze9_1_PD7_0,0.47058823529411764,0.8117647058823529,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+989,Boltz-1,5f52_1_ASP_2,,0.0,,
+990,Boltz-1,6xug_1_O1Q_0,,0.0,,
+991,Boltz-1,4fyv_1_DCP_2,,0.0,,
+992,Boltz-1,2hk9_1_SKM_0,0.4615384615384615,0.8153846153846154,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+993,Boltz-1,6v2a_1_ASN_3,,0.0,,
+994,Boltz-1,1rqp_1_SAM_0,,0.0,,
+995,Boltz-1,2wr8_1_SAH_1,0.5294117647058824,0.788235294117647,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+996,Boltz-1,5gqi_1_ATP_7,,0.0,,
+997,Boltz-1,2vdf_1_OCT_0,1.1666666666666665,0.5333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1}",{}
+998,Boltz-1,4qa8_1_PJZ_0,1.625,0.35,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 6, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+999,Boltz-1,5k66_1_ASN-GLU_0,,0.0,,
+1000,Boltz-1,3gf4_1_FAD_1,,0.0,,
+1001,Boltz-1,4tvd_1_BGC_4,,0.0,,
+1002,Boltz-1,1u8u_1_OCA_0,0.5,0.8,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+1003,Boltz-1,2xta_1_ACO_0,,0.0,,
+1004,Boltz-1,5hhz_1_ZME_0,1.0909090909090908,0.5636363636363637,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2}"
+1005,Boltz-1,4xdr_1_ADN_0,,0.0,,
+1006,Boltz-1,6uqy_2_AT3_0,0.4666666666666666,0.8133333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1007,Boltz-1,5k4h_2_GLU_3,,0.0,,
+1008,Boltz-1,4tvd_1_GLC_0,,0.0,,
+1009,Boltz-1,1pj2_1_FUM_0,,0.0,,
+1010,Boltz-1,6o70_1_ACK_1,0.49999999999999994,0.8,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+1011,Boltz-1,2zd0_1_TRP_9,0.625,0.75,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+1012,Boltz-1,1uf5_1_CDT_0,0.35714285714285715,0.8571428571428572,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+1013,Boltz-1,4o95_1_245_0,1.3333333333333335,0.46666666666666656,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}",{'UNL:ASP:VdWContact': 1}
+1014,Boltz-1,3ad9_1_NAD_0,,0.0,,
+1015,Boltz-1,5k63_1_ASN-GLY_0,,0.0,,
+1016,Boltz-1,4rpm_1_HXC_0,,0.0,,
+1017,Boltz-1,4pfx_1_UDP_0,0.15789473684210514,0.9368421052631579,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1018,Boltz-1,2gah_1_NAD_0,,0.0,,
+1019,Boltz-1,6pa2_1_ASP_2,,0.0,,
+1020,Boltz-1,4h2f_1_ADN_0,0.6666666666666666,0.7333333333333334,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+1021,Boltz-1,4u63_1_FAD_0,0.607142857142857,0.7571428571428572,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1022,Boltz-1,4o0f_1_GLY_3,,0.0,,
+1023,Boltz-1,2q6k_1_ADN_1,0.11764705882352944,0.9529411764705882,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+1024,Boltz-1,5fiu_1_Y3J_3,,0.0,,
+1025,Boltz-1,5f2t_1_PLM_0,1.3529411764705883,0.45882352941176463,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+1026,Boltz-1,3ada_1_NAD_0,,0.0,,
+1027,Boltz-1,4b4v_1_L34_0,0.5384615384615384,0.7846153846153846,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1028,Boltz-1,4uoc_1_NCN_1,,0.0,,
+1029,Boltz-1,3uni_1_SAL_0,,0.0,,
+1030,Boltz-1,3o7j_1_2AL_0,0.5714285714285714,0.7714285714285715,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+1031,Boltz-1,2v7v_1_5FD_0,,0.0,,
+1032,Boltz-1,4rhe_1_FMN_6,,0.0,,
+1033,Boltz-1,5fxf_1_BEZ_0,,0.0,,
+1034,Boltz-1,2wwc_1_CHT_2,1.0,0.6,"{'UNL:GLY:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}",{}
+1035,Boltz-1,6qkr_1_FAD_0,0.6666666666666666,0.7333333333333334,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 3, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+1036,Boltz-1,3inr_1_GDU_0,,0.0,,
+1037,Boltz-1,4idk_1_1FE_0,1.1818181818181819,0.5272727272727272,"{'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 2}"
+1038,Boltz-1,6yao_1_OJ2_0,0.9999999999999999,0.6000000000000001,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+1039,Boltz-1,6ea9_1_9BG_0,0.5,0.8,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+1040,Boltz-1,6ur1_2_AT3_0,0.6666666666666667,0.7333333333333333,"{'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1041,Boltz-1,4mig_1_G3F_2,,0.0,,
+1042,Boltz-1,6wyz_1_DGL_1,,0.0,,
+1043,Boltz-1,2v7t_1_SAH_4,,0.0,,
+1044,Boltz-1,3ad7_1_NAD_0,,0.0,,
+1045,Boltz-1,5hw0_1_GLU_2,,0.0,,
+1046,Boltz-1,5hqx_1_EDZ_0,0.7857142857142858,0.6857142857142857,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1047,Boltz-1,2q37_1_3AL_0,0.41666666666666674,0.8333333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+1048,Boltz-1,6n19_2_K8V_0,,0.0,,
+1049,Boltz-1,2v7w_1_5FD_0,,0.0,,
+1050,Boltz-1,4phs_1_UDP_0,0.23529411764705885,0.9058823529411765,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1051,Boltz-1,4ydx_1_TCE_0,1.0,0.6,{'UNL:CYS:VdWContact': 1},"{'UNL:CYS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}"
+1052,Boltz-1,4xfm_1_THE_0,0.5,0.8,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+1053,Boltz-1,3ub9_1_NHY_1,0.7142857142857143,0.7142857142857143,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 2}"
+1054,Boltz-1,1tkg_1_SSA_0,0.631578947368421,0.7473684210526316,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+1055,Boltz-1,4o0d_1_GLY_3,,0.0,,
+1056,Boltz-1,6yap_1_OHZ_0,0.6923076923076923,0.7230769230769231,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1057,Boltz-1,6xb3_3_9BG_1,0.5714285714285713,0.7714285714285715,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+1058,Boltz-1,4kgx_1_CTP_5,,0.0,,
+1059,Boltz-1,3se5_1_ANP_2,,0.0,,
+1060,Boltz-1,6gbf_1_AMP_0,,0.0,,
+1061,Boltz-1,2v7u_1_SAM_2,,0.0,,
+1062,Boltz-1,2gag_1_FOA_0,,0.0,,
+1063,Boltz-1,4uuw_1_AMP_0,,0.0,,
+1064,Boltz-1,4phr_1_UDP_0,0.4705882352941177,0.8117647058823529,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+1065,Boltz-1,1o72_2_PC_0,0.75,0.7,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+1066,Boltz-1,4oal_2_245_0,1.2727272727272727,0.49090909090909096,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1}"
+1067,Boltz-1,1hg0_1_SIN_1,,0.0,,
+1068,Boltz-1,3zjx_1_BOG_0,0.888888888888889,0.6444444444444444,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1069,Boltz-1,6pa6_2_ASN_0,,0.0,,
+1070,Boltz-1,1qaw_1_TRP_7,0.3157894736842105,0.8736842105263158,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
+1071,AF3-Single-Seq,3s6a_1_ANP_0,0.5,0.8,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+1072,AF3-Single-Seq,2gf3_2_FOA_1,0.6666666666666667,0.7333333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+1073,AF3-Single-Seq,1v2g_1_OCA_0,0.375,0.85,"{'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+1074,AF3-Single-Seq,2r4e_1_13P_0,0.4285714285714286,0.8285714285714285,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1075,AF3-Single-Seq,3ub7_1_ACM_1,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+1076,AF3-Single-Seq,4cdn_2_FAD_0,0.40740740740740733,0.837037037037037,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1077,AF3-Single-Seq,6yaq_1_OHZ_0,0.7499999999999999,0.7000000000000001,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1078,AF3-Single-Seq,4cnl_1_CHT_1,1.3333333333333335,0.46666666666666656,"{'UNL:MET:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}",{}
+1079,AF3-Single-Seq,5k45_2_GLU_1,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1080,AF3-Single-Seq,2zcz_2_TRP_3,0.375,0.85,"{'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+1081,AF3-Single-Seq,5fxd_1_H7Y_1,0.6666666666666666,0.7333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1082,AF3-Single-Seq,5k3o_2_ASP_0,0.2857142857142857,0.8857142857142857,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+1083,AF3-Single-Seq,5fxe_1_CIY_1,0.25,0.9,"{'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1084,AF3-Single-Seq,5ida_1_BMA_0,0.25,0.9,"{'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+1085,AF3-Single-Seq,4osy_1_GLY_3,,0.0,,
+1086,AF3-Single-Seq,5k62_1_ASN-VAL_0,,0.0,,
+1087,AF3-Single-Seq,5b5s_1_BOG_0,0.5555555555555556,0.7777777777777778,"{'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+1088,AF3-Single-Seq,1tke_1_SER_0,0.36363636363636365,0.8545454545454545,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+1089,AF3-Single-Seq,6paa_1_ASP_2,0.8333333333333335,0.6666666666666666,"{'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1090,AF3-Single-Seq,2gag_1_NAD_0,0.14285714285714285,0.9428571428571428,"{'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1091,AF3-Single-Seq,6o6y_1_ACK_0,0.625,0.75,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+1092,AF3-Single-Seq,3zec_1_ANP_0,0.4166666666666667,0.8333333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1093,AF3-Single-Seq,5mh1_1_BMA_0,,0.0,,
+1094,AF3-Single-Seq,5dnc_1_ASN_2,,0.0,,
+1095,AF3-Single-Seq,5u82_2_ZN0_0,,0.0,,
+1096,AF3-Single-Seq,3wrb_1_GDE_0,0.49999999999999994,0.8,"{'UNL:ARG:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1097,AF3-Single-Seq,6ep5_1_ADP_1,0.3125,0.875,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1098,AF3-Single-Seq,2vfu_1_MTL_0,0.3333333333333333,0.8666666666666667,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1099,AF3-Single-Seq,3zzs_1_TRP_3,,0.0,,
+1100,AF3-Single-Seq,6ryz_1_SAM_2,0.2272727272727273,0.9090909090909091,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1101,AF3-Single-Seq,5hmr_1_FDZ_0,0.39999999999999997,0.8400000000000001,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+1102,AF3-Single-Seq,2hs3_1_FGR_0,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+1103,AF3-Single-Seq,6etf_1_AMP_0,,0.0,,
+1104,AF3-Single-Seq,3jqm_1_GTP_5,0.4444444444444445,0.8222222222222222,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1105,AF3-Single-Seq,3eca_1_ASP_3,0.2142857142857142,0.9142857142857144,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+1106,AF3-Single-Seq,4osx_1_GLY_2,,0.0,,
+1107,AF3-Single-Seq,2ze9_1_PD7_0,0.8333333333333334,0.6666666666666666,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1108,AF3-Single-Seq,5f52_1_ASP_2,,0.0,,
+1109,AF3-Single-Seq,6xug_1_O1Q_0,,0.0,,
+1110,AF3-Single-Seq,4fyv_1_DCP_2,0.46666666666666656,0.8133333333333334,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1111,AF3-Single-Seq,2hk9_1_SKM_0,0.33333333333333326,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1112,AF3-Single-Seq,6v2a_1_ASN_3,,0.0,,
+1113,AF3-Single-Seq,1rqp_1_SAM_0,0.1578947368421053,0.9368421052631579,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1114,AF3-Single-Seq,2wr8_1_SAH_1,0.375,0.85,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1115,AF3-Single-Seq,5gqi_1_ATP_7,0.36363636363636354,0.8545454545454546,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+1116,AF3-Single-Seq,2vdf_1_OCT_0,1.2,0.52,"{'UNL:ALA:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}",{}
+1117,AF3-Single-Seq,4qa8_1_PJZ_0,1.818181818181818,0.2727272727272728,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1118,AF3-Single-Seq,5k66_1_ASN-GLU_0,,0.0,,
+1119,AF3-Single-Seq,3gf4_1_FAD_1,0.25,0.9,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+1120,AF3-Single-Seq,4tvd_1_BGC_4,0.5714285714285715,0.7714285714285714,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1}","{'UNL:GLU:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+1121,AF3-Single-Seq,1u8u_1_OCA_0,0.30769230769230765,0.8769230769230769,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+1122,AF3-Single-Seq,2xta_1_ACO_0,0.5555555555555556,0.7777777777777778,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 4, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+1123,AF3-Single-Seq,5hhz_1_ZME_0,1.0,0.6,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2}"
+1124,AF3-Single-Seq,4xdr_1_ADN_0,,0.0,,
+1125,AF3-Single-Seq,6uqy_2_AT3_0,0.4615384615384615,0.8153846153846154,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1126,AF3-Single-Seq,5k4h_2_GLU_3,0.4545454545454546,0.8181818181818181,"{'UNL:ARG:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1127,AF3-Single-Seq,4tvd_1_GLC_0,0.7999999999999999,0.68,"{'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LYS:VdWContact': 2}"
+1128,AF3-Single-Seq,1pj2_1_FUM_0,,0.0,,
+1129,AF3-Single-Seq,6o70_1_ACK_1,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+1130,AF3-Single-Seq,2zd0_1_TRP_9,0.39999999999999997,0.8400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+1131,AF3-Single-Seq,1uf5_1_CDT_0,0.26315789473684215,0.8947368421052632,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+1132,AF3-Single-Seq,4o95_1_245_0,1.4,0.44000000000000006,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}",{'UNL:ASP:VdWContact': 1}
+1133,AF3-Single-Seq,3ad9_1_NAD_0,0.19047619047619052,0.9238095238095237,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1134,AF3-Single-Seq,5k63_1_ASN-GLY_0,,0.0,,
+1135,AF3-Single-Seq,4rpm_1_HXC_0,,0.0,,
+1136,AF3-Single-Seq,4pfx_1_UDP_0,0.23809523809523803,0.9047619047619048,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1137,AF3-Single-Seq,2gah_1_NAD_0,0.31818181818181823,0.8727272727272727,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1138,AF3-Single-Seq,6pa2_1_ASP_2,,0.0,,
+1139,AF3-Single-Seq,4h2f_1_ADN_0,0.5384615384615384,0.7846153846153846,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+1140,AF3-Single-Seq,4u63_1_FAD_0,0.18518518518518523,0.9259259259259259,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1141,AF3-Single-Seq,4o0f_1_GLY_3,,0.0,,
+1142,AF3-Single-Seq,2q6k_1_ADN_1,0.4166666666666667,0.8333333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+1143,AF3-Single-Seq,5fiu_1_Y3J_3,0.10526315789473689,0.9578947368421052,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+1144,AF3-Single-Seq,5f2t_1_PLM_0,0.9375,0.625,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:Hydrophobic': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+1145,AF3-Single-Seq,3ada_1_NAD_0,0.2799999999999999,0.888,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1146,AF3-Single-Seq,4b4v_1_L34_0,0.15000000000000008,0.94,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1147,AF3-Single-Seq,4uoc_1_NCN_1,1.0625,0.575,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1148,AF3-Single-Seq,3uni_1_SAL_0,,0.0,,
+1149,AF3-Single-Seq,3o7j_1_2AL_0,0.30769230769230765,0.8769230769230769,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+1150,AF3-Single-Seq,2v7v_1_5FD_0,0.14999999999999997,0.9400000000000001,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1151,AF3-Single-Seq,4rhe_1_FMN_6,0.3846153846153846,0.8461538461538461,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1152,AF3-Single-Seq,5fxf_1_BEZ_0,0.22222222222222227,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1153,AF3-Single-Seq,2wwc_1_CHT_2,1.0,0.6,{'UNL:TYR:VdWContact': 1},{}
+1154,AF3-Single-Seq,6qkr_1_FAD_0,0.3636363636363636,0.8545454545454545,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+1155,AF3-Single-Seq,3inr_1_GDU_0,0.125,0.95,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+1156,AF3-Single-Seq,4idk_1_1FE_0,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ILE:VdWContact': 1}","{'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 2}"
+1157,AF3-Single-Seq,6yao_1_OJ2_0,,0.0,,
+1158,AF3-Single-Seq,6ea9_1_9BG_0,0.34782608695652184,0.8608695652173912,"{'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+1159,AF3-Single-Seq,6ur1_2_AT3_0,0.25,0.9,"{'UNL:ALA:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1160,AF3-Single-Seq,4mig_1_G3F_2,,0.0,,
+1161,AF3-Single-Seq,6wyz_1_DGL_1,0.33333333333333337,0.8666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+1162,AF3-Single-Seq,2v7t_1_SAH_4,0.3076923076923077,0.8769230769230769,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1163,AF3-Single-Seq,3ad7_1_NAD_0,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1164,AF3-Single-Seq,5hw0_1_GLU_2,0.41666666666666674,0.8333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+1165,AF3-Single-Seq,5hqx_1_EDZ_0,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1166,AF3-Single-Seq,2q37_1_3AL_0,0.3846153846153845,0.8461538461538463,"{'UNL:ARG:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+1167,AF3-Single-Seq,6n19_2_K8V_0,,0.0,,
+1168,AF3-Single-Seq,2v7w_1_5FD_0,0.31578947368421056,0.8736842105263158,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1169,AF3-Single-Seq,4phs_1_UDP_0,0.32,0.872,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1170,AF3-Single-Seq,4ydx_1_TCE_0,0.0,1.0,"{'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}"
+1171,AF3-Single-Seq,4xfm_1_THE_0,0.25,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+1172,AF3-Single-Seq,3ub9_1_NHY_1,1.0,0.6,"{'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 2}"
+1173,AF3-Single-Seq,1tkg_1_SSA_0,0.4,0.84,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+1174,AF3-Single-Seq,4o0d_1_GLY_3,,0.0,,
+1175,AF3-Single-Seq,6yap_1_OHZ_0,0.6818181818181818,0.7272727272727273,"{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1176,AF3-Single-Seq,6xb3_3_9BG_1,0.6296296296296298,0.7481481481481481,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+1177,AF3-Single-Seq,4kgx_1_CTP_5,0.5,0.8,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1178,AF3-Single-Seq,3se5_1_ANP_2,0.368421052631579,0.8526315789473684,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1179,AF3-Single-Seq,6gbf_1_AMP_0,,0.0,,
+1180,AF3-Single-Seq,2v7u_1_SAM_2,0.375,0.85,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 4, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1181,AF3-Single-Seq,2gag_1_FOA_0,0.4666666666666666,0.8133333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1182,AF3-Single-Seq,4uuw_1_AMP_0,0.2727272727272727,0.8909090909090909,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+1183,AF3-Single-Seq,4phr_1_UDP_0,0.125,0.95,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+1184,AF3-Single-Seq,1o72_2_PC_0,0.875,0.65,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+1185,AF3-Single-Seq,4oal_2_245_0,0.9166666666666667,0.6333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1}"
+1186,AF3-Single-Seq,1hg0_1_SIN_1,1.625,0.35,{'UNL:SER:VdWContact': 2},"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+1187,AF3-Single-Seq,3zjx_1_BOG_0,0.7647058823529413,0.6941176470588235,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 4}","{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1188,AF3-Single-Seq,6pa6_2_ASN_0,,0.0,,
+1189,AF3-Single-Seq,1qaw_1_TRP_7,0.17647058823529416,0.9294117647058824,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
+1190,AF3,3s6a_1_ANP_0,0.39999999999999997,0.8400000000000001,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+1191,AF3,2gf3_2_FOA_1,0.8181818181818182,0.6727272727272727,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+1192,AF3,1v2g_1_OCA_0,0.5,0.8,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+1193,AF3,2r4e_1_13P_0,0.5,0.8,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1194,AF3,3ub7_1_ACM_1,0.4444444444444444,0.8222222222222222,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+1195,AF3,4cdn_2_FAD_0,0.49999999999999994,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1196,AF3,6yaq_1_OHZ_0,0.7894736842105262,0.6842105263157895,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1197,AF3,4cnl_1_CHT_1,1.3333333333333335,0.46666666666666656,"{'UNL:MET:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}",{}
+1198,AF3,5k45_2_GLU_1,0.4166666666666667,0.8333333333333333,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1199,AF3,2zcz_2_TRP_3,0.7058823529411765,0.7176470588235294,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+1200,AF3,5fxd_1_H7Y_1,0.9166666666666666,0.6333333333333333,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1201,AF3,5k3o_2_ASP_0,0.6363636363636365,0.7454545454545454,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+1202,AF3,5fxe_1_CIY_1,0.7692307692307693,0.6923076923076923,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1203,AF3,5ida_1_BMA_0,0.16666666666666663,0.9333333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+1204,AF3,4osy_1_GLY_3,,0.0,,
+1205,AF3,5k62_1_ASN-VAL_0,,0.0,,
+1206,AF3,5b5s_1_BOG_0,0.7142857142857142,0.7142857142857143,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+1207,AF3,1tke_1_SER_0,0.625,0.75,"{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+1208,AF3,6paa_1_ASP_2,0.2857142857142857,0.8857142857142857,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1209,AF3,2gag_1_NAD_0,0.6153846153846154,0.7538461538461538,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1210,AF3,6o6y_1_ACK_0,0.923076923076923,0.6307692307692307,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+1211,AF3,3zec_1_ANP_0,0.611111111111111,0.7555555555555555,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1212,AF3,5mh1_1_BMA_0,,0.0,,
+1213,AF3,5dnc_1_ASN_2,,0.0,,
+1214,AF3,5u82_2_ZN0_0,,0.0,,
+1215,AF3,3wrb_1_GDE_0,0.5454545454545454,0.7818181818181819,"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1216,AF3,6ep5_1_ADP_1,0.3333333333333333,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1217,AF3,2vfu_1_MTL_0,0.33333333333333337,0.8666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1218,AF3,3zzs_1_TRP_3,,0.0,,
+1219,AF3,6ryz_1_SAM_2,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1220,AF3,5hmr_1_FDZ_0,0.7272727272727272,0.7090909090909091,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+1221,AF3,2hs3_1_FGR_0,0.05882352941176469,0.9764705882352941,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+1222,AF3,6etf_1_AMP_0,,0.0,,
+1223,AF3,3jqm_1_GTP_5,1.1739130434782608,0.5304347826086957,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 5, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1224,AF3,3eca_1_ASP_3,0.4285714285714285,0.8285714285714286,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+1225,AF3,4osx_1_GLY_2,,0.0,,
+1226,AF3,2ze9_1_PD7_0,0.5625,0.775,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1227,AF3,5f52_1_ASP_2,,0.0,,
+1228,AF3,6xug_1_O1Q_0,,0.0,,
+1229,AF3,4fyv_1_DCP_2,0.6428571428571428,0.7428571428571429,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1230,AF3,2hk9_1_SKM_0,0.5384615384615384,0.7846153846153846,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1231,AF3,6v2a_1_ASN_3,,0.0,,
+1232,AF3,1rqp_1_SAM_0,0.5833333333333334,0.7666666666666666,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1233,AF3,2wr8_1_SAH_1,0.4,0.84,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1234,AF3,5gqi_1_ATP_7,0.6666666666666666,0.7333333333333334,"{'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+1235,AF3,2vdf_1_OCT_0,1.2,0.52,"{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}",{}
+1236,AF3,4qa8_1_PJZ_0,1.5555555555555558,0.37777777777777766,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 6, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1237,AF3,5k66_1_ASN-GLU_0,,0.0,,
+1238,AF3,3gf4_1_FAD_1,0.4375,0.825,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+1239,AF3,4tvd_1_BGC_4,0.5,0.8,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3}","{'UNL:GLU:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+1240,AF3,1u8u_1_OCA_0,0.28571428571428575,0.8857142857142857,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+1241,AF3,2xta_1_ACO_0,0.4,0.84,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+1242,AF3,5hhz_1_ZME_0,1.0,0.6,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2}"
+1243,AF3,4xdr_1_ADN_0,,0.0,,
+1244,AF3,6uqy_2_AT3_0,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1245,AF3,5k4h_2_GLU_3,0.5384615384615385,0.7846153846153846,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1246,AF3,4tvd_1_GLC_0,1.25,0.5,{'UNL:ALA:VdWContact': 1},"{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LYS:VdWContact': 2}"
+1247,AF3,1pj2_1_FUM_0,,0.0,,
+1248,AF3,6o70_1_ACK_1,0.4615384615384615,0.8153846153846154,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+1249,AF3,2zd0_1_TRP_9,0.5294117647058824,0.788235294117647,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+1250,AF3,1uf5_1_CDT_0,0.3571428571428572,0.8571428571428571,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+1251,AF3,4o95_1_245_0,1.2222222222222223,0.5111111111111111,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}",{'UNL:ASP:VdWContact': 1}
+1252,AF3,3ad9_1_NAD_0,0.6153846153846154,0.7538461538461538,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1253,AF3,5k63_1_ASN-GLY_0,,0.0,,
+1254,AF3,4rpm_1_HXC_0,,0.0,,
+1255,AF3,4pfx_1_UDP_0,0.15,0.94,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1256,AF3,2gah_1_NAD_0,0.48,0.808,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1257,AF3,6pa2_1_ASP_2,,0.0,,
+1258,AF3,4h2f_1_ADN_0,0.375,0.85,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+1259,AF3,4u63_1_FAD_0,0.5357142857142856,0.7857142857142858,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1260,AF3,4o0f_1_GLY_3,,0.0,,
+1261,AF3,2q6k_1_ADN_1,0.17647058823529416,0.9294117647058824,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+1262,AF3,5fiu_1_Y3J_3,0.38095238095238093,0.8476190476190476,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+1263,AF3,5f2t_1_PLM_0,1.2222222222222223,0.5111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1}"
+1264,AF3,3ada_1_NAD_0,0.6086956521739132,0.7565217391304347,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1265,AF3,4b4v_1_L34_0,0.44000000000000006,0.824,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1266,AF3,4uoc_1_NCN_1,0.10526315789473689,0.9578947368421052,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1267,AF3,3uni_1_SAL_0,,0.0,,
+1268,AF3,3o7j_1_2AL_0,0.49999999999999994,0.8,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+1269,AF3,2v7v_1_5FD_0,0.5454545454545454,0.7818181818181819,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1270,AF3,4rhe_1_FMN_6,0.4210526315789473,0.8315789473684211,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1271,AF3,5fxf_1_BEZ_0,0.1111111111111111,0.9555555555555556,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1272,AF3,2wwc_1_CHT_2,1.5,0.4,"{'UNL:GLY:VdWContact': 1, 'UNL:TYR:VdWContact': 2}",{}
+1273,AF3,6qkr_1_FAD_0,0.5625,0.775,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+1274,AF3,3inr_1_GDU_0,0.8,0.6799999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 4}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+1275,AF3,4idk_1_1FE_0,1.0,0.6,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 2}"
+1276,AF3,6yao_1_OJ2_0,1.0,0.6,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+1277,AF3,6ea9_1_9BG_0,0.5714285714285713,0.7714285714285715,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+1278,AF3,6ur1_2_AT3_0,0.8125,0.675,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1279,AF3,4mig_1_G3F_2,,0.0,,
+1280,AF3,6wyz_1_DGL_1,0.4444444444444445,0.8222222222222222,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+1281,AF3,2v7t_1_SAH_4,0.5833333333333335,0.7666666666666666,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1282,AF3,3ad7_1_NAD_0,0.6799999999999999,0.728,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1283,AF3,5hw0_1_GLU_2,0.2727272727272727,0.8909090909090909,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+1284,AF3,5hqx_1_EDZ_0,0.6923076923076921,0.7230769230769232,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1285,AF3,2q37_1_3AL_0,0.5,0.8,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+1286,AF3,6n19_2_K8V_0,,0.0,,
+1287,AF3,2v7w_1_5FD_0,0.5238095238095237,0.7904761904761906,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1288,AF3,4phs_1_UDP_0,0.22222222222222227,0.9111111111111111,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1289,AF3,4ydx_1_TCE_0,0.3333333333333333,0.8666666666666667,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}"
+1290,AF3,4xfm_1_THE_0,0.375,0.85,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+1291,AF3,3ub9_1_NHY_1,0.6666666666666667,0.7333333333333333,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 2}"
+1292,AF3,1tkg_1_SSA_0,0.5714285714285714,0.7714285714285715,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+1293,AF3,4o0d_1_GLY_3,,0.0,,
+1294,AF3,6yap_1_OHZ_0,0.7692307692307692,0.6923076923076923,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1295,AF3,6xb3_3_9BG_1,0.5454545454545454,0.7818181818181819,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+1296,AF3,4kgx_1_CTP_5,1.2857142857142856,0.48571428571428577,{},"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1297,AF3,3se5_1_ANP_2,0.35,0.86,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1298,AF3,6gbf_1_AMP_0,,0.0,,
+1299,AF3,2v7u_1_SAM_2,0.5833333333333335,0.7666666666666666,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1300,AF3,2gag_1_FOA_0,0.28571428571428575,0.8857142857142857,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1}","{'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1301,AF3,4uuw_1_AMP_0,0.9333333333333333,0.6266666666666667,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+1302,AF3,4phr_1_UDP_0,0.411764705882353,0.8352941176470587,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+1303,AF3,1o72_2_PC_0,0.625,0.75,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+1304,AF3,4oal_2_245_0,1.090909090909091,0.5636363636363636,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1}"
+1305,AF3,1hg0_1_SIN_1,0.5999999999999999,0.76,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+1306,AF3,3zjx_1_BOG_0,0.6666666666666667,0.7333333333333333,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1307,AF3,6pa6_2_ASN_0,,0.0,,
+1308,AF3,1qaw_1_TRP_7,0.5625,0.775,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
diff --git a/notebooks/dockgen_plif_wm_values.png b/notebooks/dockgen_plif_wm_values.png
new file mode 100644
index 00000000..a3648f3a
Binary files /dev/null and b/notebooks/dockgen_plif_wm_values.png differ
diff --git a/notebooks/dockgen_primary_ligand_relaxed_bar_chart.png b/notebooks/dockgen_primary_ligand_relaxed_bar_chart.png
new file mode 100644
index 00000000..574e0e4a
Binary files /dev/null and b/notebooks/dockgen_primary_ligand_relaxed_bar_chart.png differ
diff --git a/notebooks/dockgen_primary_ligand_relaxed_rmsd_violin_plot.png b/notebooks/dockgen_primary_ligand_relaxed_rmsd_violin_plot.png
new file mode 100644
index 00000000..7be9f7a9
Binary files /dev/null and b/notebooks/dockgen_primary_ligand_relaxed_rmsd_violin_plot.png differ
diff --git a/notebooks/dockgen_structured_plif_metrics.csv b/notebooks/dockgen_structured_plif_metrics.csv
new file mode 100644
index 00000000..eb5baa3c
--- /dev/null
+++ b/notebooks/dockgen_structured_plif_metrics.csv
@@ -0,0 +1,533 @@
+,Category,Target,Structured_EMD,Unstructured_EMD,Method_Histogram,Reference_Histogram
+0,P2Rank-Vina,3s6a_1_ANP_0,0.5,0.33333333333333337,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+1,P2Rank-Vina,2q37_1_3AL_0,0.25,0.5,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+2,P2Rank-Vina,4phs_1_UDP_0,0.75,0.38888888888888884,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+3,P2Rank-Vina,4xfm_1_THE_0,0.0,0.6666666666666666,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+4,P2Rank-Vina,1tkg_1_SSA_0,0.25,0.45454545454545453,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+5,P2Rank-Vina,1o72_2_PC_0,0.3333333333333333,0.75,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+6,DiffDock-L,1v2g_1_OCA_0,0.5,0.5833333333333334,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+7,DiffDock-L,4cdn_2_FAD_0,0.5,0.47368421052631576,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+8,DiffDock-L,5k45_2_GLU_1,0.0,0.25,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+9,DiffDock-L,5k3o_2_ASP_0,0.5,1.3333333333333333,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+10,DiffDock-L,5b5s_1_BOG_0,0.5,0.6666666666666667,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+11,DiffDock-L,6paa_1_ASP_2,0.75,0.3333333333333334,"{'UNL:ALA:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+12,DiffDock-L,2gag_1_NAD_0,0.4285714285714286,0.5909090909090908,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+13,DiffDock-L,6ep5_1_ADP_1,0.6,0.41666666666666674,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+14,DiffDock-L,2hs3_1_FGR_0,0.1428571428571429,0.4166666666666667,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+15,DiffDock-L,2ze9_1_PD7_0,0.3333333333333333,1.0714285714285716,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+16,DiffDock-L,4fyv_1_DCP_2,0.3333333333333333,0.4444444444444445,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+17,DiffDock-L,3gf4_1_FAD_1,0.22222222222222227,0.5238095238095237,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+18,DiffDock-L,1u8u_1_OCA_0,0.0,0.7272727272727272,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+19,DiffDock-L,2xta_1_ACO_0,0.0,0.5454545454545453,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+20,DiffDock-L,6uqy_2_AT3_0,0.6666666666666666,0.36363636363636365,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+21,DiffDock-L,5k4h_2_GLU_3,0.39999999999999997,0.1428571428571429,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+22,DiffDock-L,4tvd_1_GLC_0,0.5,0.6,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LYS:VdWContact': 2}"
+23,DiffDock-L,2zd0_1_TRP_9,0.19999999999999996,0.5999999999999999,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+24,DiffDock-L,3ad9_1_NAD_0,0.11111111111111116,0.7142857142857144,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 8, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+25,DiffDock-L,4pfx_1_UDP_0,0.16666666666666666,0.2727272727272727,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+26,DiffDock-L,4u63_1_FAD_0,0.39999999999999997,0.619047619047619,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+27,DiffDock-L,3ada_1_NAD_0,0.2727272727272727,0.6363636363636362,"{'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+28,DiffDock-L,4b4v_1_L34_0,0.6666666666666666,0.3529411764705882,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+29,DiffDock-L,4uoc_1_NCN_1,0.5,0.41666666666666663,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 4, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+30,DiffDock-L,2v7v_1_5FD_0,0.0,0.4,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+31,DiffDock-L,3inr_1_GDU_0,0.3333333333333333,0.42857142857142866,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+32,DiffDock-L,6wyz_1_DGL_1,0.0,0.75,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+33,DiffDock-L,2v7t_1_SAH_4,0.2857142857142857,0.375,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+34,DiffDock-L,3ad7_1_NAD_0,0.22222222222222227,0.6315789473684212,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 6, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+35,DiffDock-L,5hw0_1_GLU_2,0.6666666666666666,0.5,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+36,DiffDock-L,2v7w_1_5FD_0,0.16666666666666666,0.4666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+37,DiffDock-L,4kgx_1_CTP_5,0.33333333333333337,0.33333333333333337,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+38,DiffDock-L,3se5_1_ANP_2,0.75,0.36363636363636365,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+39,DiffDock-L,2v7u_1_SAM_2,0.4444444444444445,0.2857142857142857,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+40,DiffDock-L,4uuw_1_AMP_0,0.19999999999999996,0.75,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+41,DiffDock-L,4phr_1_UDP_0,0.8,0.5454545454545454,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+42,DiffDock-L,1hg0_1_SIN_1,0.2,0.8571428571428571,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+43,DynamicBind,3s6a_1_ANP_0,0.5,0.10000000000000009,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+44,DynamicBind,1v2g_1_OCA_0,0.3333333333333333,0.5833333333333334,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+45,DynamicBind,2r4e_1_13P_0,0.75,0.5714285714285714,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+46,DynamicBind,4cdn_2_FAD_0,0.3999999999999999,0.41176470588235287,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+47,DynamicBind,5k45_2_GLU_1,0.19999999999999996,0.28571428571428575,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+48,DynamicBind,2zcz_2_TRP_3,0.19999999999999996,0.6666666666666667,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+49,DynamicBind,5k3o_2_ASP_0,1.0,1.0,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+50,DynamicBind,5ida_1_BMA_0,0.0,0.375,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+51,DynamicBind,6paa_1_ASP_2,0.16666666666666669,0.4444444444444444,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+52,DynamicBind,2gag_1_NAD_0,0.7999999999999999,0.47368421052631576,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+53,DynamicBind,6o6y_1_ACK_0,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+54,DynamicBind,3wrb_1_GDE_0,0.0,0.45454545454545453,"{'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+55,DynamicBind,6ep5_1_ADP_1,1.25,0.18181818181818188,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+56,DynamicBind,2vfu_1_MTL_0,0.16666666666666669,0.33333333333333326,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+57,DynamicBind,3jqm_1_GTP_5,0.3333333333333333,1.0833333333333335,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+58,DynamicBind,3eca_1_ASP_3,0.49999999999999994,0.5454545454545455,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+59,DynamicBind,2ze9_1_PD7_0,0.25,0.9444444444444444,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+60,DynamicBind,4fyv_1_DCP_2,0.3333333333333333,0.6923076923076923,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+61,DynamicBind,1rqp_1_SAM_0,0.14285714285714285,0.55,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+62,DynamicBind,2wr8_1_SAH_1,0.19999999999999996,0.4666666666666666,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+63,DynamicBind,5gqi_1_ATP_7,0.0,0.7857142857142857,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+64,DynamicBind,3gf4_1_FAD_1,0.2,0.5789473684210528,"{'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+65,DynamicBind,1u8u_1_OCA_0,0.5,0.7000000000000001,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+66,DynamicBind,2xta_1_ACO_0,0.25,0.5833333333333334,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+67,DynamicBind,5k4h_2_GLU_3,0.16666666666666669,0.5555555555555556,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+68,DynamicBind,6o70_1_ACK_1,0.5,0.18181818181818182,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+69,DynamicBind,1uf5_1_CDT_0,0.25,0.25,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+70,DynamicBind,3ad9_1_NAD_0,0.25,0.33333333333333326,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+71,DynamicBind,2gah_1_NAD_0,0.375,0.6666666666666667,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+72,DynamicBind,4h2f_1_ADN_0,0.19999999999999996,1.0,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+73,DynamicBind,2q6k_1_ADN_1,0.0,0.36363636363636365,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+74,DynamicBind,5fiu_1_Y3J_3,0.5,0.0,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+75,DynamicBind,3ada_1_NAD_0,0.8333333333333334,0.380952380952381,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+76,DynamicBind,4b4v_1_L34_0,0.5,0.42105263157894746,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+77,DynamicBind,4uoc_1_NCN_1,0.7999999999999999,0.5,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+78,DynamicBind,3o7j_1_2AL_0,0.3333333333333333,0.25,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+79,DynamicBind,2v7v_1_5FD_0,0.6000000000000001,0.2142857142857143,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+80,DynamicBind,4rhe_1_FMN_6,0.28571428571428575,0.5000000000000001,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+81,DynamicBind,5fxf_1_BEZ_0,0.0,0.33333333333333337,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+82,DynamicBind,6qkr_1_FAD_0,0.7142857142857143,0.3809523809523809,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+83,DynamicBind,3inr_1_GDU_0,0.7142857142857143,0.2857142857142857,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+84,DynamicBind,6ea9_1_9BG_0,0.0,0.5000000000000001,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+85,DynamicBind,6wyz_1_DGL_1,0.75,1.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+86,DynamicBind,2v7t_1_SAH_4,0.16666666666666669,0.3529411764705881,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+87,DynamicBind,3ad7_1_NAD_0,0.375,0.40909090909090906,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+88,DynamicBind,5hw0_1_GLU_2,0.3333333333333333,0.375,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+89,DynamicBind,2q37_1_3AL_0,0.3333333333333333,0.25,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+90,DynamicBind,2v7w_1_5FD_0,0.6000000000000001,0.26666666666666666,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+91,DynamicBind,4phs_1_UDP_0,1.0,0.30769230769230776,"{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+92,DynamicBind,4xfm_1_THE_0,0.0,0.5,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+93,DynamicBind,1tkg_1_SSA_0,0.3999999999999999,0.6923076923076923,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+94,DynamicBind,6xb3_3_9BG_1,0.7999999999999998,0.6000000000000001,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 3, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+95,DynamicBind,4kgx_1_CTP_5,0.3999999999999999,0.5999999999999999,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+96,DynamicBind,3se5_1_ANP_2,1.25,0.33333333333333337,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+97,DynamicBind,2v7u_1_SAM_2,0.3333333333333333,0.6111111111111112,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+98,DynamicBind,2gag_1_FOA_0,0.3333333333333333,0.6153846153846155,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+99,DynamicBind,4uuw_1_AMP_0,0.19999999999999996,0.6363636363636364,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+100,DynamicBind,1hg0_1_SIN_1,0.75,0.6666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+101,DynamicBind,3zjx_1_BOG_0,0.0,0.19999999999999996,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+102,NeuralPLexer,3s6a_1_ANP_0,0.4000000000000001,0.125,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+103,NeuralPLexer,1v2g_1_OCA_0,0.5,0.5,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+104,NeuralPLexer,2r4e_1_13P_0,0.3999999999999999,1.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+105,NeuralPLexer,4cdn_2_FAD_0,0.6666666666666666,0.4,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+106,NeuralPLexer,5k45_2_GLU_1,0.25,0.16666666666666666,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+107,NeuralPLexer,2zcz_2_TRP_3,0.25,0.9285714285714284,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+108,NeuralPLexer,5k3o_2_ASP_0,0.3333333333333333,0.8571428571428572,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+109,NeuralPLexer,5b5s_1_BOG_0,0.0,0.19999999999999996,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+110,NeuralPLexer,6paa_1_ASP_2,0.2,0.2857142857142858,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+111,NeuralPLexer,2gag_1_NAD_0,0.11111111111111116,0.5000000000000002,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 7, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+112,NeuralPLexer,6o6y_1_ACK_0,0.3333333333333333,0.7692307692307692,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+113,NeuralPLexer,3zec_1_ANP_0,0.25,0.75,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+114,NeuralPLexer,3wrb_1_GDE_0,0.0,0.5555555555555556,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+115,NeuralPLexer,6ep5_1_ADP_1,0.8333333333333334,0.3846153846153847,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+116,NeuralPLexer,2vfu_1_MTL_0,0.16666666666666669,0.3333333333333333,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+117,NeuralPLexer,2hs3_1_FGR_0,0.3333333333333333,0.44444444444444436,"{'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+118,NeuralPLexer,3jqm_1_GTP_5,0.0,0.8333333333333334,"{'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+119,NeuralPLexer,3eca_1_ASP_3,0.33333333333333326,0.5,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+120,NeuralPLexer,2ze9_1_PD7_0,1.0,0.42857142857142855,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+121,NeuralPLexer,4fyv_1_DCP_2,0.0,0.4545454545454545,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+122,NeuralPLexer,2hk9_1_SKM_0,0.0,0.11111111111111116,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+123,NeuralPLexer,1rqp_1_SAM_0,0.0,0.5625,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+124,NeuralPLexer,2wr8_1_SAH_1,0.4,0.45454545454545453,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+125,NeuralPLexer,5gqi_1_ATP_7,0.3333333333333333,0.19999999999999996,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+126,NeuralPLexer,3gf4_1_FAD_1,0.09090909090909094,0.4444444444444445,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+127,NeuralPLexer,1u8u_1_OCA_0,0.3333333333333333,0.6000000000000001,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+128,NeuralPLexer,2xta_1_ACO_0,0.6000000000000001,0.7692307692307694,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+129,NeuralPLexer,5k4h_2_GLU_3,0.0,0.16666666666666666,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+130,NeuralPLexer,4tvd_1_GLC_0,1.0,0.6666666666666666,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LYS:VdWContact': 2}"
+131,NeuralPLexer,6o70_1_ACK_1,0.0,0.11111111111111116,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+132,NeuralPLexer,1uf5_1_CDT_0,0.6666666666666667,0.3636363636363635,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+133,NeuralPLexer,3ad9_1_NAD_0,0.11111111111111116,0.5555555555555556,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+134,NeuralPLexer,4pfx_1_UDP_0,0.1428571428571429,0.21428571428571438,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+135,NeuralPLexer,2gah_1_NAD_0,0.5,0.13333333333333341,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+136,NeuralPLexer,4h2f_1_ADN_0,0.5,0.6666666666666666,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+137,NeuralPLexer,4u63_1_FAD_0,0.7999999999999999,0.2666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+138,NeuralPLexer,2q6k_1_ADN_1,0.3333333333333333,0.5,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+139,NeuralPLexer,5fiu_1_Y3J_3,0.33333333333333337,0.33333333333333326,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+140,NeuralPLexer,3ada_1_NAD_0,0.6666666666666666,0.4666666666666667,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+141,NeuralPLexer,4uoc_1_NCN_1,0.8333333333333333,0.3571428571428571,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+142,NeuralPLexer,3o7j_1_2AL_0,0.0,0.375,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+143,NeuralPLexer,2v7v_1_5FD_0,0.375,0.5714285714285714,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+144,NeuralPLexer,4rhe_1_FMN_6,0.8,0.5625,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+145,NeuralPLexer,6qkr_1_FAD_0,0.33333333333333337,0.2857142857142858,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 6, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+146,NeuralPLexer,3inr_1_GDU_0,0.3333333333333333,0.5555555555555557,"{'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 4}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+147,NeuralPLexer,6ea9_1_9BG_0,0.5999999999999999,0.6153846153846153,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+148,NeuralPLexer,6wyz_1_DGL_1,0.6666666666666667,1.7999999999999998,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+149,NeuralPLexer,2v7t_1_SAH_4,0.125,0.375,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+150,NeuralPLexer,3ad7_1_NAD_0,0.14285714285714285,0.6428571428571428,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 5, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 4, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+151,NeuralPLexer,5hw0_1_GLU_2,0.5,0.8,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+152,NeuralPLexer,2q37_1_3AL_0,0.0,0.5714285714285716,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+153,NeuralPLexer,2v7w_1_5FD_0,0.25,0.5,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+154,NeuralPLexer,4phs_1_UDP_0,0.2,0.24999999999999994,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+155,NeuralPLexer,4xfm_1_THE_0,0.0,0.5,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+156,NeuralPLexer,1tkg_1_SSA_0,0.3999999999999999,0.7999999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+157,NeuralPLexer,6xb3_3_9BG_1,0.5555555555555557,0.5,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+158,NeuralPLexer,4kgx_1_CTP_5,0.19999999999999996,0.16666666666666669,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+159,NeuralPLexer,3se5_1_ANP_2,1.3333333333333333,0.16666666666666666,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+160,NeuralPLexer,2v7u_1_SAM_2,0.14285714285714285,0.588235294117647,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+161,NeuralPLexer,4phr_1_UDP_0,0.0,0.23076923076923078,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+162,NeuralPLexer,1o72_2_PC_0,0.0,1.5,"{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+163,NeuralPLexer,1hg0_1_SIN_1,0.25,0.6666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+164,RFAA,1v2g_1_OCA_0,0.5,0.3,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+165,RFAA,2hs3_1_FGR_0,0.49999999999999994,0.26666666666666666,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+166,RFAA,4fyv_1_DCP_2,0.3333333333333333,0.7142857142857143,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+167,RFAA,5gqi_1_ATP_7,0.19999999999999996,1.0,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+168,RFAA,3gf4_1_FAD_1,0.1111111111111111,0.25,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+169,RFAA,1u8u_1_OCA_0,0.25,0.6000000000000001,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+170,RFAA,3o7j_1_2AL_0,0.0,0.3333333333333333,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+171,RFAA,1tkg_1_SSA_0,0.25,0.5,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+172,RFAA,4kgx_1_CTP_5,0.0,0.375,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+173,RFAA,2v7u_1_SAM_2,0.14285714285714285,0.30769230769230776,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+174,Chai-1-Single-Seq,3s6a_1_ANP_0,0.5,0.33333333333333326,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+175,Chai-1-Single-Seq,1v2g_1_OCA_0,0.5,0.6923076923076923,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+176,Chai-1-Single-Seq,2r4e_1_13P_0,0.75,0.8333333333333334,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+177,Chai-1-Single-Seq,4cdn_2_FAD_0,0.2,0.55,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+178,Chai-1-Single-Seq,5k45_2_GLU_1,0.6,0.5555555555555555,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+179,Chai-1-Single-Seq,2zcz_2_TRP_3,0.3333333333333333,0.5000000000000001,"{'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+180,Chai-1-Single-Seq,5k3o_2_ASP_0,0.5,0.5714285714285716,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+181,Chai-1-Single-Seq,5ida_1_BMA_0,0.6666666666666666,0.2,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+182,Chai-1-Single-Seq,5b5s_1_BOG_0,0.0,1.1666666666666665,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+183,Chai-1-Single-Seq,1tke_1_SER_0,0.33333333333333337,0.7142857142857143,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+184,Chai-1-Single-Seq,2gag_1_NAD_0,0.2857142857142857,0.75,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+185,Chai-1-Single-Seq,6o6y_1_ACK_0,0.6000000000000001,0.7272727272727273,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+186,Chai-1-Single-Seq,3zec_1_ANP_0,0.3333333333333333,0.5,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+187,Chai-1-Single-Seq,3wrb_1_GDE_0,0.5,1.0,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+188,Chai-1-Single-Seq,6ep5_1_ADP_1,0.8,0.33333333333333326,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+189,Chai-1-Single-Seq,2vfu_1_MTL_0,0.3333333333333333,0.19999999999999996,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+190,Chai-1-Single-Seq,6ryz_1_SAM_2,0.2,0.15000000000000002,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+191,Chai-1-Single-Seq,2hs3_1_FGR_0,0.16666666666666663,0.33333333333333326,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+192,Chai-1-Single-Seq,3eca_1_ASP_3,0.25,0.4285714285714286,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+193,Chai-1-Single-Seq,2ze9_1_PD7_0,0.0,0.9230769230769231,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+194,Chai-1-Single-Seq,4fyv_1_DCP_2,0.5,0.6,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+195,Chai-1-Single-Seq,2hk9_1_SKM_0,0.75,0.6000000000000001,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+196,Chai-1-Single-Seq,1rqp_1_SAM_0,0.3333333333333333,0.2142857142857143,"{'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+197,Chai-1-Single-Seq,2wr8_1_SAH_1,0.5,0.4,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+198,Chai-1-Single-Seq,5gqi_1_ATP_7,0.5,0.25,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+199,Chai-1-Single-Seq,3gf4_1_FAD_1,0.7142857142857143,0.1999999999999999,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+200,Chai-1-Single-Seq,1u8u_1_OCA_0,0.25,0.8666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+201,Chai-1-Single-Seq,2xta_1_ACO_0,0.5,0.4444444444444444,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+202,Chai-1-Single-Seq,6uqy_2_AT3_0,0.0,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+203,Chai-1-Single-Seq,5k4h_2_GLU_3,0.75,0.3,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+204,Chai-1-Single-Seq,1pj2_1_FUM_0,0.3333333333333333,0.8333333333333334,"{'UNL:ARG:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2}"
+205,Chai-1-Single-Seq,6o70_1_ACK_1,0.6000000000000001,0.3333333333333334,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+206,Chai-1-Single-Seq,2zd0_1_TRP_9,0.19999999999999996,0.3846153846153846,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+207,Chai-1-Single-Seq,1uf5_1_CDT_0,0.6,0.5,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+208,Chai-1-Single-Seq,3ad9_1_NAD_0,0.14285714285714285,0.6,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 5, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+209,Chai-1-Single-Seq,2gah_1_NAD_0,0.375,0.5625,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+210,Chai-1-Single-Seq,4h2f_1_ADN_0,0.0,0.375,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+211,Chai-1-Single-Seq,4u63_1_FAD_0,0.2857142857142857,0.6818181818181819,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+212,Chai-1-Single-Seq,2q6k_1_ADN_1,0.3333333333333333,0.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+213,Chai-1-Single-Seq,5fiu_1_Y3J_3,0.33333333333333337,0.21428571428571425,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+214,Chai-1-Single-Seq,3ada_1_NAD_0,0.14285714285714285,0.6875,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 5, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+215,Chai-1-Single-Seq,4b4v_1_L34_0,0.33333333333333337,0.38888888888888895,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+216,Chai-1-Single-Seq,4uoc_1_NCN_1,0.5,0.20000000000000007,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+217,Chai-1-Single-Seq,3o7j_1_2AL_0,0.6,0.42857142857142855,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+218,Chai-1-Single-Seq,2v7v_1_5FD_0,0.11111111111111116,0.6428571428571428,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+219,Chai-1-Single-Seq,4rhe_1_FMN_6,1.0,0.8333333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+220,Chai-1-Single-Seq,6qkr_1_FAD_0,0.15384615384615374,0.5357142857142856,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+221,Chai-1-Single-Seq,3inr_1_GDU_0,0.6666666666666666,0.5833333333333334,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+222,Chai-1-Single-Seq,6ea9_1_9BG_0,0.5,0.6000000000000001,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+223,Chai-1-Single-Seq,6wyz_1_DGL_1,0.3999999999999999,0.7142857142857143,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+224,Chai-1-Single-Seq,2v7t_1_SAH_4,0.6000000000000001,0.3571428571428571,"{'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+225,Chai-1-Single-Seq,3ad7_1_NAD_0,0.14285714285714285,0.6428571428571428,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+226,Chai-1-Single-Seq,5hw0_1_GLU_2,0.75,0.8333333333333334,"{'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+227,Chai-1-Single-Seq,2q37_1_3AL_0,0.6,0.4999999999999999,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+228,Chai-1-Single-Seq,2v7w_1_5FD_0,0.0,0.38461538461538464,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+229,Chai-1-Single-Seq,4phs_1_UDP_0,0.0,0.5,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+230,Chai-1-Single-Seq,4xfm_1_THE_0,0.3333333333333333,0.4000000000000001,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+231,Chai-1-Single-Seq,1tkg_1_SSA_0,0.33333333333333337,0.5,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+232,Chai-1-Single-Seq,6xb3_3_9BG_1,1.2,0.5333333333333332,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+233,Chai-1-Single-Seq,4kgx_1_CTP_5,0.25,0.2222222222222222,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+234,Chai-1-Single-Seq,3se5_1_ANP_2,0.25,0.4285714285714285,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+235,Chai-1-Single-Seq,2v7u_1_SAM_2,0.16666666666666669,0.4166666666666667,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+236,Chai-1-Single-Seq,4uuw_1_AMP_0,0.7999999999999999,0.6666666666666666,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+237,Chai-1-Single-Seq,4phr_1_UDP_0,0.5714285714285714,0.36363636363636365,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+238,Chai-1-Single-Seq,1o72_2_PC_0,0.0,0.5,"{'UNL:ARG:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+239,Chai-1-Single-Seq,1hg0_1_SIN_1,0.0,0.75,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+240,Chai-1-Single-Seq,3zjx_1_BOG_0,0.0,0.9230769230769231,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+241,Chai-1,3s6a_1_ANP_0,0.6666666666666666,0.14285714285714285,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+242,Chai-1,1v2g_1_OCA_0,0.6,0.6923076923076924,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+243,Chai-1,2r4e_1_13P_0,0.5,0.20000000000000007,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+244,Chai-1,4cdn_2_FAD_0,0.4,0.5500000000000002,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+245,Chai-1,5k45_2_GLU_1,0.6,0.5555555555555555,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+246,Chai-1,2zcz_2_TRP_3,0.25,0.5000000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+247,Chai-1,5k3o_2_ASP_0,0.5,0.5,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+248,Chai-1,5ida_1_BMA_0,0.6666666666666666,0.2,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+249,Chai-1,1tke_1_SER_0,0.5,0.5714285714285714,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+250,Chai-1,6paa_1_ASP_2,0.2857142857142857,0.375,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+251,Chai-1,2gag_1_NAD_0,0.6666666666666666,0.35294117647058826,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+252,Chai-1,6o6y_1_ACK_0,0.6666666666666666,1.0,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+253,Chai-1,3wrb_1_GDE_0,0.5,0.8,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+254,Chai-1,2vfu_1_MTL_0,0.25,0.11111111111111105,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+255,Chai-1,2ze9_1_PD7_0,0.0,0.5625,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+256,Chai-1,4fyv_1_DCP_2,0.5,0.29999999999999993,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+257,Chai-1,2hk9_1_SKM_0,0.5,0.5000000000000001,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+258,Chai-1,1rqp_1_SAM_0,0.16666666666666666,0.25,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+259,Chai-1,2wr8_1_SAH_1,0.14285714285714285,0.35714285714285715,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+260,Chai-1,5gqi_1_ATP_7,0.5,0.3333333333333333,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+261,Chai-1,3gf4_1_FAD_1,0.33333333333333337,0.3888888888888889,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+262,Chai-1,1u8u_1_OCA_0,0.3333333333333333,0.5714285714285715,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+263,Chai-1,2xta_1_ACO_0,0.5,0.25,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+264,Chai-1,6o70_1_ACK_1,0.3333333333333333,0.5625,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+265,Chai-1,2zd0_1_TRP_9,0.5,0.4545454545454545,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+266,Chai-1,1uf5_1_CDT_0,0.6666666666666666,0.29999999999999993,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+267,Chai-1,3ad9_1_NAD_0,0.2857142857142857,0.4000000000000001,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+268,Chai-1,4pfx_1_UDP_0,0.0,0.1666666666666666,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+269,Chai-1,2gah_1_NAD_0,0.8,1.1666666666666665,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+270,Chai-1,4h2f_1_ADN_0,0.3333333333333333,0.625,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+271,Chai-1,4u63_1_FAD_0,0.28571428571428564,0.6000000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+272,Chai-1,2q6k_1_ADN_1,0.5,0.375,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+273,Chai-1,5fiu_1_Y3J_3,0.5,0.21428571428571427,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+274,Chai-1,3ada_1_NAD_0,0.2857142857142857,0.46666666666666673,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+275,Chai-1,4b4v_1_L34_0,0.2,0.5263157894736842,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+276,Chai-1,4uoc_1_NCN_1,0.2,0.16666666666666663,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+277,Chai-1,3o7j_1_2AL_0,0.6,0.42857142857142855,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+278,Chai-1,2v7v_1_5FD_0,0.5,0.5714285714285714,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+279,Chai-1,5fxf_1_BEZ_0,0.0,0.44444444444444436,"{'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+280,Chai-1,6qkr_1_FAD_0,0.39999999999999997,0.2857142857142858,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+281,Chai-1,3inr_1_GDU_0,0.19999999999999996,0.24999999999999994,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+282,Chai-1,6ea9_1_9BG_0,0.4444444444444445,0.5384615384615385,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+283,Chai-1,4mig_1_G3F_2,0.3333333333333333,0.875,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+284,Chai-1,2v7t_1_SAH_4,0.2857142857142857,0.33333333333333337,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+285,Chai-1,3ad7_1_NAD_0,0.2857142857142857,0.6000000000000001,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+286,Chai-1,5hw0_1_GLU_2,0.4,0.33333333333333326,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+287,Chai-1,2q37_1_3AL_0,0.6,0.28571428571428575,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 3, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+288,Chai-1,2v7w_1_5FD_0,0.42857142857142855,0.5714285714285714,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+289,Chai-1,4phs_1_UDP_0,0.0,0.08333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+290,Chai-1,4xfm_1_THE_0,0.3333333333333333,0.25,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+291,Chai-1,1tkg_1_SSA_0,0.5,0.7692307692307693,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+292,Chai-1,6xb3_3_9BG_1,0.7999999999999998,0.7647058823529411,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+293,Chai-1,4kgx_1_CTP_5,0.25,0.33333333333333337,"{'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+294,Chai-1,2v7u_1_SAM_2,0.16666666666666666,0.25000000000000006,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+295,Chai-1,2gag_1_FOA_0,0.0,0.3999999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+296,Chai-1,4uuw_1_AMP_0,1.0,0.6666666666666666,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+297,Chai-1,4phr_1_UDP_0,0.375,0.41666666666666663,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+298,Chai-1,1hg0_1_SIN_1,0.75,1.2857142857142856,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+299,Chai-1,3zjx_1_BOG_0,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+300,Chai-1,1qaw_1_TRP_7,0.5,1.1428571428571428,"{'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
+301,Boltz-1-Single-Seq,3s6a_1_ANP_0,0.5,0.25,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+302,Boltz-1-Single-Seq,1v2g_1_OCA_0,0.5,0.6000000000000001,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+303,Boltz-1-Single-Seq,2r4e_1_13P_0,0.5,0.125,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+304,Boltz-1-Single-Seq,4cdn_2_FAD_0,0.6000000000000001,0.4500000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+305,Boltz-1-Single-Seq,5k45_2_GLU_1,0.25,0.5,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+306,Boltz-1-Single-Seq,2zcz_2_TRP_3,0.6,0.6666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+307,Boltz-1-Single-Seq,5k3o_2_ASP_0,0.5,0.5555555555555556,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+308,Boltz-1-Single-Seq,5ida_1_BMA_0,0.5,0.16666666666666666,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+309,Boltz-1-Single-Seq,1tke_1_SER_0,0.33333333333333337,0.6666666666666666,"{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+310,Boltz-1-Single-Seq,6paa_1_ASP_2,0.3333333333333333,0.4444444444444445,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+311,Boltz-1-Single-Seq,6o6y_1_ACK_0,0.6666666666666666,1.0,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+312,Boltz-1-Single-Seq,3zec_1_ANP_0,0.5,0.6666666666666666,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+313,Boltz-1-Single-Seq,3wrb_1_GDE_0,0.3333333333333333,0.7272727272727273,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+314,Boltz-1-Single-Seq,6ep5_1_ADP_1,0.5,0.18181818181818182,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+315,Boltz-1-Single-Seq,2vfu_1_MTL_0,0.0,0.0,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+316,Boltz-1-Single-Seq,6ryz_1_SAM_2,0.375,0.6470588235294117,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+317,Boltz-1-Single-Seq,2hs3_1_FGR_0,0.8,0.46153846153846145,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+318,Boltz-1-Single-Seq,3jqm_1_GTP_5,0.9,1.0666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+319,Boltz-1-Single-Seq,3eca_1_ASP_3,0.2857142857142857,0.5555555555555556,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+320,Boltz-1-Single-Seq,2ze9_1_PD7_0,0.6666666666666667,0.5384615384615383,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+321,Boltz-1-Single-Seq,4fyv_1_DCP_2,0.6666666666666666,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+322,Boltz-1-Single-Seq,2hk9_1_SKM_0,0.6666666666666666,0.375,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+323,Boltz-1-Single-Seq,1rqp_1_SAM_0,0.5454545454545454,0.5625,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+324,Boltz-1-Single-Seq,2wr8_1_SAH_1,0.5,0.5,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+325,Boltz-1-Single-Seq,3gf4_1_FAD_1,0.3,0.5454545454545454,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+326,Boltz-1-Single-Seq,1u8u_1_OCA_0,0.25,0.8333333333333334,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+327,Boltz-1-Single-Seq,6uqy_2_AT3_0,0.0,0.6666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+328,Boltz-1-Single-Seq,5k4h_2_GLU_3,0.33333333333333337,0.5714285714285714,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+329,Boltz-1-Single-Seq,4tvd_1_GLC_0,1.0,0.75,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LYS:VdWContact': 2}"
+330,Boltz-1-Single-Seq,2zd0_1_TRP_9,0.6666666666666666,0.6363636363636364,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+331,Boltz-1-Single-Seq,1uf5_1_CDT_0,0.5,0.3333333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+332,Boltz-1-Single-Seq,4pfx_1_UDP_0,0.14285714285714285,0.24999999999999997,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+333,Boltz-1-Single-Seq,4h2f_1_ADN_0,0.6666666666666667,0.6666666666666666,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+334,Boltz-1-Single-Seq,4u63_1_FAD_0,0.375,0.7142857142857142,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+335,Boltz-1-Single-Seq,2q6k_1_ADN_1,0.0,0.25,"{'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+336,Boltz-1-Single-Seq,5fiu_1_Y3J_3,0.5714285714285714,0.4285714285714285,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+337,Boltz-1-Single-Seq,4b4v_1_L34_0,0.2,0.55,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+338,Boltz-1-Single-Seq,4uoc_1_NCN_1,0.14285714285714285,0.08333333333333326,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+339,Boltz-1-Single-Seq,3o7j_1_2AL_0,0.6666666666666666,0.5,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+340,Boltz-1-Single-Seq,2v7v_1_5FD_0,0.4444444444444445,0.4666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+341,Boltz-1-Single-Seq,4rhe_1_FMN_6,0.5,0.38461538461538464,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+342,Boltz-1-Single-Seq,5fxf_1_BEZ_0,0.0,0.2222222222222222,"{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+343,Boltz-1-Single-Seq,6qkr_1_FAD_0,0.125,0.7727272727272728,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 3, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+344,Boltz-1-Single-Seq,3inr_1_GDU_0,0.25,0.5833333333333335,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 4}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+345,Boltz-1-Single-Seq,6ea9_1_9BG_0,0.2,0.3846153846153846,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+346,Boltz-1-Single-Seq,6wyz_1_DGL_1,0.2,0.6,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+347,Boltz-1-Single-Seq,2v7t_1_SAH_4,0.5,0.26666666666666666,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+348,Boltz-1-Single-Seq,5hw0_1_GLU_2,0.25,0.33333333333333326,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+349,Boltz-1-Single-Seq,2q37_1_3AL_0,0.6666666666666666,0.2857142857142858,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+350,Boltz-1-Single-Seq,2v7w_1_5FD_0,0.375,0.6,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+351,Boltz-1-Single-Seq,4phs_1_UDP_0,0.2,0.38461538461538475,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+352,Boltz-1-Single-Seq,4xfm_1_THE_0,0.3333333333333333,0.7142857142857143,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+353,Boltz-1-Single-Seq,1tkg_1_SSA_0,0.5999999999999999,0.5833333333333334,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+354,Boltz-1-Single-Seq,6xb3_3_9BG_1,0.33333333333333337,0.625,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+355,Boltz-1-Single-Seq,4kgx_1_CTP_5,0.5,0.5,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+356,Boltz-1-Single-Seq,3se5_1_ANP_2,0.5,0.2857142857142857,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+357,Boltz-1-Single-Seq,2v7u_1_SAM_2,0.4444444444444445,0.5625,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+358,Boltz-1-Single-Seq,4uuw_1_AMP_0,0.75,0.8999999999999999,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+359,Boltz-1-Single-Seq,4phr_1_UDP_0,0.3333333333333333,0.4545454545454546,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+360,Boltz-1-Single-Seq,1o72_2_PC_0,0.5,1.0,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+361,Boltz-1-Single-Seq,1hg0_1_SIN_1,0.25,0.8571428571428571,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+362,Boltz-1-Single-Seq,1qaw_1_TRP_7,0.6,0.45454545454545436,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
+363,Boltz-1,3s6a_1_ANP_0,0.4,0.25,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+364,Boltz-1,1v2g_1_OCA_0,0.5,0.6363636363636364,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+365,Boltz-1,2r4e_1_13P_0,1.0,0.125,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+366,Boltz-1,4cdn_2_FAD_0,0.5000000000000001,0.368421052631579,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+367,Boltz-1,5k45_2_GLU_1,0.25,0.375,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+368,Boltz-1,2zcz_2_TRP_3,0.6,0.6363636363636362,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+369,Boltz-1,5k3o_2_ASP_0,0.5,0.5555555555555556,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+370,Boltz-1,5ida_1_BMA_0,0.0,0.16666666666666666,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+371,Boltz-1,1tke_1_SER_0,0.5,0.6666666666666666,"{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+372,Boltz-1,6paa_1_ASP_2,0.2,0.4444444444444445,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+373,Boltz-1,6o6y_1_ACK_0,0.6666666666666666,1.0833333333333335,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+374,Boltz-1,2vfu_1_MTL_0,0.5,0.0,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+375,Boltz-1,2hs3_1_FGR_0,0.3333333333333333,0.3076923076923077,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+376,Boltz-1,3jqm_1_GTP_5,1.0,1.2142857142857142,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 2, 'UNL:LYS:VdWContact': 4, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+377,Boltz-1,2ze9_1_PD7_0,0.5,0.4615384615384615,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+378,Boltz-1,2hk9_1_SKM_0,0.6666666666666666,0.40000000000000013,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+379,Boltz-1,2wr8_1_SAH_1,0.5,0.5454545454545454,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+380,Boltz-1,1u8u_1_OCA_0,0.25,0.5833333333333334,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+381,Boltz-1,6uqy_2_AT3_0,0.0,0.5833333333333335,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+382,Boltz-1,6o70_1_ACK_1,0.6000000000000001,0.4666666666666666,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+383,Boltz-1,2zd0_1_TRP_9,0.6666666666666666,0.6,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+384,Boltz-1,1uf5_1_CDT_0,0.5,0.30000000000000004,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+385,Boltz-1,4pfx_1_UDP_0,0.14285714285714285,0.16666666666666663,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+386,Boltz-1,4h2f_1_ADN_0,0.6666666666666667,0.6666666666666666,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+387,Boltz-1,4u63_1_FAD_0,0.2857142857142857,0.7142857142857142,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+388,Boltz-1,2q6k_1_ADN_1,0.3333333333333333,0.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+389,Boltz-1,4b4v_1_L34_0,0.2,0.6190476190476191,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+390,Boltz-1,3o7j_1_2AL_0,0.6666666666666666,0.5,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+391,Boltz-1,6qkr_1_FAD_0,0.2222222222222222,0.8571428571428571,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 3, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+392,Boltz-1,6ea9_1_9BG_0,0.19999999999999996,0.6153846153846154,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+393,Boltz-1,2q37_1_3AL_0,0.6666666666666666,0.4999999999999999,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+394,Boltz-1,4phs_1_UDP_0,0.2,0.24999999999999997,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+395,Boltz-1,4xfm_1_THE_0,0.3333333333333333,0.6000000000000001,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+396,Boltz-1,1tkg_1_SSA_0,0.5999999999999999,0.6428571428571429,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+397,Boltz-1,6xb3_3_9BG_1,0.16666666666666666,0.7333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+398,Boltz-1,4phr_1_UDP_0,0.3333333333333333,0.5454545454545455,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+399,Boltz-1,1o72_2_PC_0,0.3333333333333333,1.0,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+400,Boltz-1,3zjx_1_BOG_0,0.0,1.0,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+401,Boltz-1,1qaw_1_TRP_7,0.5,0.5333333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
+402,AF3-Single-Seq,3s6a_1_ANP_0,0.8999999999999999,0.16666666666666669,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+403,AF3-Single-Seq,1v2g_1_OCA_0,0.3333333333333333,0.5384615384615384,"{'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+404,AF3-Single-Seq,2r4e_1_13P_0,0.3999999999999999,0.44444444444444453,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+405,AF3-Single-Seq,4cdn_2_FAD_0,0.3999999999999999,0.4090909090909091,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+406,AF3-Single-Seq,5k45_2_GLU_1,0.16666666666666669,0.44444444444444436,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+407,AF3-Single-Seq,5k3o_2_ASP_0,0.33333333333333337,0.25,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+408,AF3-Single-Seq,5b5s_1_BOG_0,0.0,0.7142857142857144,"{'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+409,AF3-Single-Seq,1tke_1_SER_0,0.6666666666666667,0.5,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+410,AF3-Single-Seq,2gag_1_NAD_0,0.2857142857142857,0.28571428571428586,"{'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+411,AF3-Single-Seq,6o6y_1_ACK_0,0.0,0.7142857142857142,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+412,AF3-Single-Seq,3zec_1_ANP_0,0.5,0.375,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+413,AF3-Single-Seq,6ep5_1_ADP_1,0.8,0.2727272727272728,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+414,AF3-Single-Seq,2vfu_1_MTL_0,0.0,0.49999999999999994,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+415,AF3-Single-Seq,6ryz_1_SAM_2,0.39999999999999997,0.4117647058823529,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+416,AF3-Single-Seq,2hs3_1_FGR_0,0.1428571428571429,0.4545454545454546,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+417,AF3-Single-Seq,3jqm_1_GTP_5,0.0,0.5714285714285715,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+418,AF3-Single-Seq,3eca_1_ASP_3,0.75,0.4000000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+419,AF3-Single-Seq,2ze9_1_PD7_0,0.6666666666666667,1.1333333333333333,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+420,AF3-Single-Seq,4fyv_1_DCP_2,0.6666666666666667,0.4166666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+421,AF3-Single-Seq,2hk9_1_SKM_0,0.0,0.3846153846153845,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+422,AF3-Single-Seq,1rqp_1_SAM_0,0.125,0.36363636363636365,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+423,AF3-Single-Seq,2wr8_1_SAH_1,0.33333333333333337,0.39999999999999997,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+424,AF3-Single-Seq,5gqi_1_ATP_7,0.0,0.5714285714285714,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+425,AF3-Single-Seq,3gf4_1_FAD_1,0.10000000000000003,0.40909090909090917,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+426,AF3-Single-Seq,1u8u_1_OCA_0,0.6666666666666666,0.6000000000000001,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+427,AF3-Single-Seq,2xta_1_ACO_0,0.3999999999999999,0.7692307692307694,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 4, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 4, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+428,AF3-Single-Seq,6o70_1_ACK_1,0.3333333333333333,0.3333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+429,AF3-Single-Seq,1uf5_1_CDT_0,0.49999999999999994,0.46153846153846156,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+430,AF3-Single-Seq,3ad9_1_NAD_0,0.28571428571428575,0.4285714285714286,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+431,AF3-Single-Seq,4pfx_1_UDP_0,0.8333333333333334,0.26666666666666666,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+432,AF3-Single-Seq,2gah_1_NAD_0,0.28571428571428575,0.6,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+433,AF3-Single-Seq,4h2f_1_ADN_0,0.0,0.7000000000000001,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+434,AF3-Single-Seq,4u63_1_FAD_0,0.33333333333333326,0.2380952380952382,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+435,AF3-Single-Seq,2q6k_1_ADN_1,0.3333333333333333,0.4444444444444445,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+436,AF3-Single-Seq,5fiu_1_Y3J_3,0.2,0.21428571428571425,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+437,AF3-Single-Seq,3ada_1_NAD_0,0.33333333333333326,0.4736842105263158,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+438,AF3-Single-Seq,4b4v_1_L34_0,0.5,0.0625,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+439,AF3-Single-Seq,4uoc_1_NCN_1,1.0,1.0909090909090908,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+440,AF3-Single-Seq,3o7j_1_2AL_0,0.5999999999999999,0.625,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+441,AF3-Single-Seq,2v7v_1_5FD_0,0.0,0.21428571428571436,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+442,AF3-Single-Seq,4rhe_1_FMN_6,0.3333333333333333,0.5,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+443,AF3-Single-Seq,6qkr_1_FAD_0,0.1111111111111111,0.5416666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+444,AF3-Single-Seq,3inr_1_GDU_0,0.19999999999999996,0.27272727272727265,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+445,AF3-Single-Seq,6ea9_1_9BG_0,0.3333333333333333,0.4705882352941176,"{'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+446,AF3-Single-Seq,6wyz_1_DGL_1,0.25,0.625,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+447,AF3-Single-Seq,2v7t_1_SAH_4,0.33333333333333337,0.2941176470588235,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+448,AF3-Single-Seq,3ad7_1_NAD_0,0.28571428571428575,0.10526315789473689,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+449,AF3-Single-Seq,5hw0_1_GLU_2,1.0,0.4444444444444445,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+450,AF3-Single-Seq,2q37_1_3AL_0,0.3333333333333333,0.3999999999999999,"{'UNL:ARG:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+451,AF3-Single-Seq,2v7w_1_5FD_0,0.14285714285714285,0.41666666666666663,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+452,AF3-Single-Seq,4phs_1_UDP_0,0.28571428571428575,0.4444444444444444,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+453,AF3-Single-Seq,4xfm_1_THE_0,0.39999999999999997,0.14285714285714285,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+454,AF3-Single-Seq,6xb3_3_9BG_1,0.4999999999999999,0.7058823529411764,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+455,AF3-Single-Seq,4kgx_1_CTP_5,0.7999999999999998,0.36363636363636365,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+456,AF3-Single-Seq,3se5_1_ANP_2,0.39999999999999997,0.3571428571428571,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+457,AF3-Single-Seq,2v7u_1_SAM_2,0.25,0.4375,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 4, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+458,AF3-Single-Seq,2gag_1_FOA_0,0.3333333333333333,0.5,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+459,AF3-Single-Seq,4phr_1_UDP_0,0.5999999999999999,0.27272727272727276,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+460,AF3-Single-Seq,1o72_2_PC_0,0.3333333333333333,1.2,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+461,AF3-Single-Seq,3zjx_1_BOG_0,0.3333333333333333,0.8571428571428572,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 4}","{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+462,AF3-Single-Seq,1qaw_1_TRP_7,0.19999999999999996,0.16666666666666663,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
+463,AF3,3s6a_1_ANP_0,0.5,0.33333333333333326,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}"
+464,AF3,1v2g_1_OCA_0,0.5,0.5,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+465,AF3,2r4e_1_13P_0,0.6666666666666667,0.4000000000000001,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+466,AF3,4cdn_2_FAD_0,0.5,0.5000000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+467,AF3,5k45_2_GLU_1,0.5,0.33333333333333326,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+468,AF3,2zcz_2_TRP_3,0.6,0.75,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 6}"
+469,AF3,5k3o_2_ASP_0,0.5,0.7142857142857144,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+470,AF3,5ida_1_BMA_0,0.0,0.19999999999999996,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+471,AF3,5b5s_1_BOG_0,0.0,1.0,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1}"
+472,AF3,1tke_1_SER_0,0.6666666666666667,0.6000000000000001,"{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}","{'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1}"
+473,AF3,6paa_1_ASP_2,0.2,0.3333333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+474,AF3,2gag_1_NAD_0,0.375,0.7222222222222222,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+475,AF3,6o6y_1_ACK_0,0.5,1.0,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 4}"
+476,AF3,3zec_1_ANP_0,0.4,0.6923076923076923,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+477,AF3,3wrb_1_GDE_0,0.0,0.6666666666666667,"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+478,AF3,6ep5_1_ADP_1,0.0,0.4166666666666666,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+479,AF3,2vfu_1_MTL_0,0.5,0.25,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+480,AF3,6ryz_1_SAM_2,0.375,0.5555555555555556,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+481,AF3,2hs3_1_FGR_0,0.4285714285714286,0.19999999999999998,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}"
+482,AF3,3jqm_1_GTP_5,0.9,1.3846153846153844,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 5, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+483,AF3,3eca_1_ASP_3,0.2857142857142857,0.5714285714285715,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+484,AF3,2ze9_1_PD7_0,0.3333333333333333,0.6153846153846153,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+485,AF3,4fyv_1_DCP_2,0.3333333333333333,0.7272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+486,AF3,2hk9_1_SKM_0,0.6666666666666666,0.5000000000000001,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+487,AF3,1rqp_1_SAM_0,0.5555555555555556,0.6000000000000001,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+488,AF3,2wr8_1_SAH_1,0.4,0.4,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+489,AF3,5gqi_1_ATP_7,0.3333333333333333,1.0,"{'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+490,AF3,3gf4_1_FAD_1,0.3,0.49999999999999994,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+491,AF3,1u8u_1_OCA_0,0.5,0.4,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}"
+492,AF3,2xta_1_ACO_0,0.0,0.5714285714285714,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+493,AF3,6uqy_2_AT3_0,0.0,0.6363636363636364,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+494,AF3,5k4h_2_GLU_3,0.6666666666666666,0.4285714285714286,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+495,AF3,6o70_1_ACK_1,0.5,0.4545454545454545,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+496,AF3,2zd0_1_TRP_9,0.6666666666666666,0.4545454545454545,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4}"
+497,AF3,1uf5_1_CDT_0,0.5,0.29999999999999993,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+498,AF3,3ad9_1_NAD_0,0.375,0.7222222222222223,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+499,AF3,4pfx_1_UDP_0,0.25,0.08333333333333334,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+500,AF3,2gah_1_NAD_0,0.2857142857142857,0.5555555555555556,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+501,AF3,4h2f_1_ADN_0,0.5,0.33333333333333337,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+502,AF3,4u63_1_FAD_0,0.375,0.6000000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+503,AF3,2q6k_1_ADN_1,0.3333333333333333,0.09090909090909083,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+504,AF3,5fiu_1_Y3J_3,0.5714285714285714,0.2857142857142857,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+505,AF3,3ada_1_NAD_0,0.2857142857142857,0.75,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+506,AF3,4b4v_1_L34_0,0.33333333333333337,0.4736842105263159,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+507,AF3,4uoc_1_NCN_1,0.14285714285714285,0.08333333333333326,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+508,AF3,3o7j_1_2AL_0,0.6,0.42857142857142855,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+509,AF3,2v7v_1_5FD_0,0.5,0.5714285714285714,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+510,AF3,4rhe_1_FMN_6,0.3333333333333333,0.4615384615384616,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+511,AF3,6qkr_1_FAD_0,0.3,0.681818181818182,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+512,AF3,3inr_1_GDU_0,0.8333333333333333,0.7857142857142857,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 4}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+513,AF3,6ea9_1_9BG_0,0.5555555555555556,0.5833333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+514,AF3,6wyz_1_DGL_1,0.25,0.6,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+515,AF3,2v7t_1_SAH_4,0.6666666666666667,0.5333333333333332,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+516,AF3,3ad7_1_NAD_0,0.2857142857142857,0.8333333333333331,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+517,AF3,5hw0_1_GLU_2,0.4,0.16666666666666666,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}"
+518,AF3,2q37_1_3AL_0,0.6666666666666666,0.33333333333333326,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+519,AF3,2v7w_1_5FD_0,0.42857142857142855,0.5714285714285714,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+520,AF3,4phs_1_UDP_0,0.3333333333333333,0.1666666666666666,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+521,AF3,4xfm_1_THE_0,0.5,0.25,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+522,AF3,1tkg_1_SSA_0,0.3333333333333333,0.6363636363636364,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2}"
+523,AF3,6xb3_3_9BG_1,0.375,0.6428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+524,AF3,3se5_1_ANP_2,0.39999999999999997,0.4666666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+525,AF3,2v7u_1_SAM_2,0.5555555555555556,0.6000000000000001,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+526,AF3,2gag_1_FOA_0,0.0,0.3999999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1}","{'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+527,AF3,4uuw_1_AMP_0,0.7999999999999999,1.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}"
+528,AF3,4phr_1_UDP_0,0.49999999999999994,0.36363636363636354,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2}"
+529,AF3,1o72_2_PC_0,0.3333333333333333,0.8,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}"
+530,AF3,1hg0_1_SIN_1,0.25,0.8333333333333334,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3}"
+531,AF3,1qaw_1_TRP_7,0.4,0.6363636363636362,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3}"
diff --git a/notebooks/dockgen_structured_vs_unstructured_emd_values.png b/notebooks/dockgen_structured_vs_unstructured_emd_values.png
new file mode 100644
index 00000000..fd4dd55f
Binary files /dev/null and b/notebooks/dockgen_structured_vs_unstructured_emd_values.png differ
diff --git a/notebooks/failed_af3_complexes_functional_keywords.png b/notebooks/failed_af3_complexes_functional_keywords.png
new file mode 100644
index 00000000..a44af721
Binary files /dev/null and b/notebooks/failed_af3_complexes_functional_keywords.png differ
diff --git a/notebooks/failed_complexes_functional_keywords_1.png b/notebooks/failed_complexes_functional_keywords_1.png
new file mode 100644
index 00000000..3013a84a
Binary files /dev/null and b/notebooks/failed_complexes_functional_keywords_1.png differ
diff --git a/notebooks/failure_modes_analysis_plotting.ipynb b/notebooks/failure_modes_analysis_plotting.ipynb
index 9d30d91a..9d9ada39 100644
--- a/notebooks/failure_modes_analysis_plotting.ipynb
+++ b/notebooks/failure_modes_analysis_plotting.ipynb
@@ -94,6 +94,8 @@
" \"rfaa\",\n",
" \"chai-lab_ss\",\n",
" \"chai-lab\",\n",
+ " \"boltz_ss\",\n",
+ " \"boltz\",\n",
" \"alphafold3_ss\",\n",
" \"alphafold3\",\n",
"]\n",
@@ -131,6 +133,7 @@
"globals()[\"neuralplexer_output_dir\"] = os.path.join(\"..\", \"forks\", \"NeuralPLexer\", \"inference\")\n",
"globals()[\"rfaa_output_dir\"] = os.path.join(\"..\", \"forks\", \"RoseTTAFold-All-Atom\", \"inference\")\n",
"globals()[\"chai-lab_output_dir\"] = os.path.join(\"..\", \"forks\", \"chai-lab\", \"inference\")\n",
+ "globals()[\"boltz_output_dir\"] = os.path.join(\"..\", \"forks\", \"boltz\", \"inference\")\n",
"globals()[\"alphafold3_output_dir\"] = os.path.join(\"..\", \"forks\", \"alphafold3\", \"inference\")\n",
"globals()[\"casp15_output_dir\"] = os.path.join(\"..\", \"data\", \"test_cases\", \"casp15\")\n",
"for config in [\"\", \"_relaxed\"]:\n",
@@ -255,6 +258,40 @@
" )\n",
" )\n",
"\n",
+ " # Boltz (Single-Seq) results\n",
+ " globals()[f\"boltz_ss_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"] = (\n",
+ " os.path.join(\n",
+ " (\n",
+ " globals()[\"casp15_output_dir\"] + config\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\"boltz_output_dir\"]\n",
+ " ),\n",
+ " (\n",
+ " f\"top_boltz_ss_ensemble_predictions_{repeat_index}\"\n",
+ " if dataset == \"casp15\"\n",
+ " else f\"boltz_ss_{dataset}_outputs_{repeat_index}{config}\"\n",
+ " ),\n",
+ " \"scoring_results.csv\" if dataset == \"casp15\" else \"bust_results.csv\",\n",
+ " )\n",
+ " )\n",
+ "\n",
+ " # Boltz results\n",
+ " globals()[f\"boltz_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"] = (\n",
+ " os.path.join(\n",
+ " (\n",
+ " globals()[\"casp15_output_dir\"] + config\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\"boltz_output_dir\"]\n",
+ " ),\n",
+ " (\n",
+ " f\"top_boltz_ensemble_predictions_{repeat_index}\"\n",
+ " if dataset == \"casp15\"\n",
+ " else f\"boltz_{dataset}_outputs_{repeat_index}{config}\"\n",
+ " ),\n",
+ " \"scoring_results.csv\" if dataset == \"casp15\" else \"bust_results.csv\",\n",
+ " )\n",
+ " )\n",
+ "\n",
" # AlphaFold 3 (Single-Seq) results\n",
" globals()[\n",
" f\"alphafold3_ss_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"\n",
@@ -298,6 +335,8 @@
" \"rfaa\": \"RFAA\",\n",
" \"chai-lab_ss\": \"Chai-1-Single-Seq\",\n",
" \"chai-lab\": \"Chai-1\",\n",
+ " \"boltz_ss\": \"Boltz-1-Single-Seq\",\n",
+ " \"boltz\": \"Boltz-1\",\n",
" \"alphafold3_ss\": \"AF3-Single-Seq\",\n",
" \"alphafold3\": \"AF3\",\n",
"}\n",
@@ -310,6 +349,8 @@
" \"rfaa\": \"DL-based blind\",\n",
" \"chai-lab_ss\": \"DL-based blind\",\n",
" \"chai-lab\": \"DL-based blind\",\n",
+ " \"boltz_ss\": \"DL-based blind\",\n",
+ " \"boltz\": \"DL-based blind\",\n",
" \"alphafold3_ss\": \"DL-based blind\",\n",
" \"alphafold3\": \"DL-based blind\",\n",
"}\n",
diff --git a/notebooks/failure_modes_analysis_plotting_plinder.ipynb b/notebooks/failure_modes_analysis_plotting_plinder.ipynb
new file mode 100644
index 00000000..1f47f7aa
--- /dev/null
+++ b/notebooks/failure_modes_analysis_plotting_plinder.ipynb
@@ -0,0 +1,1375 @@
+{
+ "cells": [
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "## Failure Modes Analysis Plotting"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Import packages"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "import copy\n",
+ "import glob\n",
+ "import os\n",
+ "from collections import Counter, defaultdict\n",
+ "\n",
+ "import matplotlib.pyplot as plt\n",
+ "import numpy as np\n",
+ "import pandas as pd\n",
+ "import pypdb\n",
+ "import seaborn as sns\n",
+ "from scipy.stats import pearsonr, spearmanr\n",
+ "\n",
+ "from posebench.analysis.inference_analysis import BUST_TEST_COLUMNS"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Configure packages"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "pd.options.mode.copy_on_write = False"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Define constants"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "# General variables\n",
+ "baseline_methods = [\n",
+ " \"vina_p2rank\",\n",
+ " \"diffdock\",\n",
+ " \"dynamicbind\",\n",
+ " \"neuralplexer\",\n",
+ " \"rfaa\",\n",
+ " \"chai-lab_ss\",\n",
+ " \"chai-lab\",\n",
+ " \"boltz_ss\",\n",
+ " \"boltz\",\n",
+ " \"alphafold3_ss\",\n",
+ " \"alphafold3\",\n",
+ "]\n",
+ "max_num_repeats_per_method = 3\n",
+ "method_max_training_cutoff_date = \"2021-09-30\"\n",
+ "\n",
+ "datasets = [\"astex_diverse\", \"posebusters_benchmark\", \"dockgen\", \"casp15\"]\n",
+ "\n",
+ "# PoseBusters Benchmark deposition dates\n",
+ "pb_deposition_dates_filepath = \"posebusters_benchmark_complex_pdb_deposition_dates.csv\"\n",
+ "assert os.path.exists(\n",
+ " pb_deposition_dates_filepath\n",
+ "), \"Please prepare the PoseBusters Benchmark complex PDB deposition dates CSV file via later steps in `failure_modes_analysis_plotting_plinder.ipynb` before proceeding.\"\n",
+ "\n",
+ "pb_pdb_id_deposition_date_mapping_df = pd.read_csv(pb_deposition_dates_filepath)\n",
+ "pb_pdb_id_deposition_date_mapping_df[\"Deposition Date\"] = pd.to_datetime(\n",
+ " pb_pdb_id_deposition_date_mapping_df[\"Deposition Date\"]\n",
+ ")\n",
+ "pb_pdb_id_deposition_date_mapping_df = pb_pdb_id_deposition_date_mapping_df[\n",
+ " pb_pdb_id_deposition_date_mapping_df[\"Deposition Date\"] > method_max_training_cutoff_date\n",
+ "]\n",
+ "pb_pdb_id_deposition_date_mapping = dict(\n",
+ " zip(\n",
+ " pb_pdb_id_deposition_date_mapping_df[\"PDB ID\"],\n",
+ " pb_pdb_id_deposition_date_mapping_df[\"Deposition Date\"].astype(str),\n",
+ " )\n",
+ ")\n",
+ "\n",
+ "# Filepaths for each baseline method\n",
+ "globals()[\"vina_output_dir\"] = os.path.join(\"..\", \"forks\", \"Vina\", \"inference\")\n",
+ "globals()[\"diffdock_output_dir\"] = os.path.join(\"..\", \"forks\", \"DiffDock\", \"inference\")\n",
+ "globals()[\"dynamicbind_output_dir\"] = os.path.join(\n",
+ " \"..\", \"forks\", \"DynamicBind\", \"inference\", \"outputs\", \"results\"\n",
+ ")\n",
+ "globals()[\"neuralplexer_output_dir\"] = os.path.join(\"..\", \"forks\", \"NeuralPLexer\", \"inference\")\n",
+ "globals()[\"rfaa_output_dir\"] = os.path.join(\"..\", \"forks\", \"RoseTTAFold-All-Atom\", \"inference\")\n",
+ "globals()[\"chai-lab_output_dir\"] = os.path.join(\"..\", \"forks\", \"chai-lab\", \"inference\")\n",
+ "globals()[\"boltz_output_dir\"] = os.path.join(\"..\", \"forks\", \"boltz\", \"inference\")\n",
+ "globals()[\"alphafold3_output_dir\"] = os.path.join(\"..\", \"forks\", \"alphafold3\", \"inference\")\n",
+ "globals()[\"casp15_output_dir\"] = os.path.join(\"..\", \"data\", \"test_cases\", \"casp15\")\n",
+ "for config in [\"\", \"_relaxed\"]:\n",
+ " for dataset in datasets:\n",
+ " for repeat_index in range(1, max_num_repeats_per_method + 1):\n",
+ " # P2Rank-Vina results\n",
+ " globals()[\n",
+ " f\"vina_p2rank_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"\n",
+ " ] = os.path.join(\n",
+ " (\n",
+ " globals()[\"casp15_output_dir\"] + config\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\"vina_output_dir\"]\n",
+ " ),\n",
+ " (\n",
+ " f\"top_vina_p2rank_ensemble_predictions_{repeat_index}\"\n",
+ " if dataset == \"casp15\"\n",
+ " else f\"vina_p2rank_{dataset}_outputs_{repeat_index}{config}\"\n",
+ " ),\n",
+ " \"scoring_results.csv\" if dataset == \"casp15\" else \"bust_results.csv\",\n",
+ " )\n",
+ "\n",
+ " # DiffDock results\n",
+ " globals()[f\"diffdock_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"] = (\n",
+ " os.path.join(\n",
+ " (\n",
+ " globals()[\"casp15_output_dir\"] + config\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\"diffdock_output_dir\"]\n",
+ " ),\n",
+ " (\n",
+ " f\"top_diffdock_ensemble_predictions_{repeat_index}\"\n",
+ " if dataset == \"casp15\"\n",
+ " else f\"diffdock_{dataset}_output_{repeat_index}{config}\"\n",
+ " ),\n",
+ " \"scoring_results.csv\" if dataset == \"casp15\" else \"bust_results.csv\",\n",
+ " )\n",
+ " )\n",
+ "\n",
+ " # DynamicBind results\n",
+ " globals()[\n",
+ " f\"dynamicbind_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"\n",
+ " ] = os.path.join(\n",
+ " (\n",
+ " globals()[\"casp15_output_dir\"] + config\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\"dynamicbind_output_dir\"]\n",
+ " ),\n",
+ " (\n",
+ " f\"top_dynamicbind_ensemble_predictions_{repeat_index}\"\n",
+ " if dataset == \"casp15\"\n",
+ " else f\"{dataset}_{repeat_index}{config}\"\n",
+ " ),\n",
+ " \"scoring_results.csv\" if dataset == \"casp15\" else \"bust_results.csv\",\n",
+ " )\n",
+ "\n",
+ " # NeuralPLexer results\n",
+ " globals()[\n",
+ " f\"neuralplexer_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"\n",
+ " ] = os.path.join(\n",
+ " (\n",
+ " globals()[\"casp15_output_dir\"] + config\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\"neuralplexer_output_dir\"]\n",
+ " ),\n",
+ " (\n",
+ " f\"top_neuralplexer_ensemble_predictions_{repeat_index}\"\n",
+ " if dataset == \"casp15\"\n",
+ " else f\"neuralplexer_{dataset}_outputs_{repeat_index}{config}\"\n",
+ " ),\n",
+ " \"scoring_results.csv\" if dataset == \"casp15\" else \"bust_results.csv\",\n",
+ " )\n",
+ "\n",
+ " # RoseTTAFold-All-Atom results\n",
+ " globals()[f\"rfaa_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"] = (\n",
+ " os.path.join(\n",
+ " (\n",
+ " globals()[\"casp15_output_dir\"] + config\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\"rfaa_output_dir\"]\n",
+ " ),\n",
+ " (\n",
+ " f\"top_rfaa_ensemble_predictions_{repeat_index}\"\n",
+ " if dataset == \"casp15\"\n",
+ " else f\"rfaa_{dataset}_outputs_{repeat_index}{config}\"\n",
+ " ),\n",
+ " \"scoring_results.csv\" if dataset == \"casp15\" else \"bust_results.csv\",\n",
+ " )\n",
+ " )\n",
+ "\n",
+ " # Chai-1 (Single-Seq) results\n",
+ " globals()[\n",
+ " f\"chai-lab_ss_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"\n",
+ " ] = os.path.join(\n",
+ " (\n",
+ " globals()[\"casp15_output_dir\"] + config\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\"chai-lab_output_dir\"]\n",
+ " ),\n",
+ " (\n",
+ " f\"top_chai-lab_ss_ensemble_predictions_{repeat_index}\"\n",
+ " if dataset == \"casp15\"\n",
+ " else f\"chai-lab_ss_{dataset}_outputs_{repeat_index}{config}\"\n",
+ " ),\n",
+ " \"scoring_results.csv\" if dataset == \"casp15\" else \"bust_results.csv\",\n",
+ " )\n",
+ "\n",
+ " # Chai-1 results\n",
+ " globals()[f\"chai-lab_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"] = (\n",
+ " os.path.join(\n",
+ " (\n",
+ " globals()[\"casp15_output_dir\"] + config\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\"chai-lab_output_dir\"]\n",
+ " ),\n",
+ " (\n",
+ " f\"top_chai-lab_ensemble_predictions_{repeat_index}\"\n",
+ " if dataset == \"casp15\"\n",
+ " else f\"chai-lab_{dataset}_outputs_{repeat_index}{config}\"\n",
+ " ),\n",
+ " \"scoring_results.csv\" if dataset == \"casp15\" else \"bust_results.csv\",\n",
+ " )\n",
+ " )\n",
+ "\n",
+ " # Boltz (Single-Seq) results\n",
+ " globals()[f\"boltz_ss_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"] = (\n",
+ " os.path.join(\n",
+ " (\n",
+ " globals()[\"casp15_output_dir\"] + config\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\"boltz_output_dir\"]\n",
+ " ),\n",
+ " (\n",
+ " f\"top_boltz_ss_ensemble_predictions_{repeat_index}\"\n",
+ " if dataset == \"casp15\"\n",
+ " else f\"boltz_ss_{dataset}_outputs_{repeat_index}{config}\"\n",
+ " ),\n",
+ " \"scoring_results.csv\" if dataset == \"casp15\" else \"bust_results.csv\",\n",
+ " )\n",
+ " )\n",
+ "\n",
+ " # Boltz results\n",
+ " globals()[f\"boltz_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"] = (\n",
+ " os.path.join(\n",
+ " (\n",
+ " globals()[\"casp15_output_dir\"] + config\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\"boltz_output_dir\"]\n",
+ " ),\n",
+ " (\n",
+ " f\"top_boltz_ensemble_predictions_{repeat_index}\"\n",
+ " if dataset == \"casp15\"\n",
+ " else f\"boltz_{dataset}_outputs_{repeat_index}{config}\"\n",
+ " ),\n",
+ " \"scoring_results.csv\" if dataset == \"casp15\" else \"bust_results.csv\",\n",
+ " )\n",
+ " )\n",
+ "\n",
+ " # AlphaFold 3 (Single-Seq) results\n",
+ " globals()[\n",
+ " f\"alphafold3_ss_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"\n",
+ " ] = os.path.join(\n",
+ " (\n",
+ " globals()[\"casp15_output_dir\"] + config\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\"alphafold3_output_dir\"]\n",
+ " ),\n",
+ " (\n",
+ " f\"top_alphafold3_ss_ensemble_predictions_{repeat_index}\"\n",
+ " if dataset == \"casp15\"\n",
+ " else f\"alphafold3_ss_{dataset}_outputs_{repeat_index}{config}\"\n",
+ " ),\n",
+ " \"scoring_results.csv\" if dataset == \"casp15\" else \"bust_results.csv\",\n",
+ " )\n",
+ "\n",
+ " # AlphaFold 3 results\n",
+ " globals()[f\"alphafold3_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"] = (\n",
+ " os.path.join(\n",
+ " (\n",
+ " globals()[\"casp15_output_dir\"] + config\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\"alphafold3_output_dir\"]\n",
+ " ),\n",
+ " (\n",
+ " f\"top_alphafold3_ensemble_predictions_{repeat_index}\"\n",
+ " if dataset == \"casp15\"\n",
+ " else f\"alphafold3_{dataset}_outputs_{repeat_index}{config}\"\n",
+ " ),\n",
+ " \"scoring_results.csv\" if dataset == \"casp15\" else \"bust_results.csv\",\n",
+ " )\n",
+ " )\n",
+ "\n",
+ "# Mappings\n",
+ "method_mapping = {\n",
+ " \"vina_p2rank\": \"P2Rank-Vina\",\n",
+ " \"diffdock\": \"DiffDock-L\",\n",
+ " \"dynamicbind\": \"DynamicBind\",\n",
+ " \"neuralplexer\": \"NeuralPLexer\",\n",
+ " \"rfaa\": \"RFAA\",\n",
+ " \"chai-lab_ss\": \"Chai-1-Single-Seq\",\n",
+ " \"chai-lab\": \"Chai-1\",\n",
+ " \"boltz_ss\": \"Boltz-1-Single-Seq\",\n",
+ " \"boltz\": \"Boltz-1\",\n",
+ " \"alphafold3_ss\": \"AF3-Single-Seq\",\n",
+ " \"alphafold3\": \"AF3\",\n",
+ "}\n",
+ "\n",
+ "method_category_mapping = {\n",
+ " \"vina_p2rank\": \"Conventional blind\",\n",
+ " \"diffdock\": \"DL-based blind\",\n",
+ " \"dynamicbind\": \"DL-based blind\",\n",
+ " \"neuralplexer\": \"DL-based blind\",\n",
+ " \"rfaa\": \"DL-based blind\",\n",
+ " \"chai-lab_ss\": \"DL-based blind\",\n",
+ " \"chai-lab\": \"DL-based blind\",\n",
+ " \"boltz_ss\": \"DL-based blind\",\n",
+ " \"boltz\": \"DL-based blind\",\n",
+ " \"alphafold3_ss\": \"DL-based blind\",\n",
+ " \"alphafold3\": \"DL-based blind\",\n",
+ "}\n",
+ "\n",
+ "dataset_mapping = {\n",
+ " \"astex_diverse\": \"Astex Diverse set\",\n",
+ " \"posebusters_benchmark\": \"Posebusters Benchmark set\",\n",
+ " \"dockgen\": \"DockGen set\",\n",
+ " \"casp15\": \"CASP15 set\",\n",
+ "}\n",
+ "\n",
+ "casp15_target_pdb_id_mapping = {\n",
+ " # NOTE: `?` indicates that the target's crystal structure is not publicly available\n",
+ " \"H1135\": \"7z8y\",\n",
+ " \"H1171v1\": \"7pbl\",\n",
+ " \"H1171v2\": \"7pbl\",\n",
+ " \"H1172v1\": \"7pbp\",\n",
+ " \"H1172v2\": \"7pbp\",\n",
+ " \"H1172v3\": \"7pbp\",\n",
+ " \"H1172v4\": \"7pbp\",\n",
+ " \"T1124\": \"7ux8\",\n",
+ " \"T1127v2\": \"?\",\n",
+ " \"T1146\": \"?\",\n",
+ " \"T1152\": \"7r1l\",\n",
+ " \"T1158v1\": \"8sx8\",\n",
+ " \"T1158v2\": \"8sxb\",\n",
+ " \"T1158v3\": \"8sx7\",\n",
+ " \"T1158v4\": \"8swn\",\n",
+ " \"T1170\": \"7pbr\",\n",
+ " \"T1181\": \"?\",\n",
+ " \"T1186\": \"?\",\n",
+ " \"T1187\": \"8ad2\",\n",
+ " \"T1188\": \"8c6z\",\n",
+ "}"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Load test results for each baseline method"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "# load and report test results for each baseline method\n",
+ "for config in [\"\"]:\n",
+ " for dataset in datasets:\n",
+ " for method in baseline_methods:\n",
+ " for repeat_index in range(1, max_num_repeats_per_method + 1):\n",
+ " method_title = method_mapping[method]\n",
+ "\n",
+ " if not os.path.exists(\n",
+ " globals()[\n",
+ " f\"{method}_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"\n",
+ " ]\n",
+ " ):\n",
+ " continue\n",
+ "\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"] = (\n",
+ " pd.read_csv(\n",
+ " globals()[\n",
+ " f\"{method}_{dataset}{config}_bust_results_csv_filepath_{repeat_index}\"\n",
+ " ]\n",
+ " )\n",
+ " )\n",
+ "\n",
+ " if dataset == \"casp15\":\n",
+ " # count the number of ligands in each target complex, and assign these corresponding numbers to the ligands (rows) of each complex\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"].loc[\n",
+ " :, \"num_target_ligands\"\n",
+ " ] = (\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"]\n",
+ " .groupby([\"target\", \"mdl\"])[\"pose\"]\n",
+ " .transform(\"count\")\n",
+ " )\n",
+ "\n",
+ " # filter out non-relevant ligand predictions, and for all methods select only their first model for each ligand\n",
+ " globals()[\n",
+ " f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"\n",
+ " ] = globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"][\n",
+ " np.where(\n",
+ " (\n",
+ " globals()[\n",
+ " f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"\n",
+ " ].relevant\n",
+ " ),\n",
+ " True,\n",
+ " False,\n",
+ " )\n",
+ " & (\n",
+ " globals()[\n",
+ " f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"\n",
+ " ].mdl\n",
+ " == 1\n",
+ " )\n",
+ " ]\n",
+ "\n",
+ " # finalize bust (i.e., scoring) results for CASP15, using dummy values for `pb_valid` and `crmsd_≤_1å`\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"].loc[\n",
+ " :, \"rmsd_≤_2å\"\n",
+ " ] = (\n",
+ " globals()[\n",
+ " f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"\n",
+ " ].loc[:, \"rmsd\"]\n",
+ " <= 2\n",
+ " )\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"].loc[\n",
+ " :, \"pdb_valid\"\n",
+ " ] = True\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"].loc[\n",
+ " :, \"crmsd_≤_1å\"\n",
+ " ] = True\n",
+ "\n",
+ " else:\n",
+ " globals()[\n",
+ " f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"\n",
+ " ] = globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"][\n",
+ " BUST_TEST_COLUMNS + [\"rmsd\", \"centroid_distance\", \"mol_id\"]\n",
+ " ]\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"].loc[\n",
+ " :, \"pb_valid\"\n",
+ " ] = (\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"]\n",
+ " .iloc[:, 1:-3]\n",
+ " .all(axis=1)\n",
+ " )\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"].loc[\n",
+ " :, \"crmsd_≤_1å\"\n",
+ " ] = (\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"][\n",
+ " \"centroid_distance\"\n",
+ " ]\n",
+ " < 1\n",
+ " )\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"].loc[\n",
+ " :, \"pdb_id\"\n",
+ " ] = globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"][\n",
+ " \"mol_id\"\n",
+ " ]\n",
+ "\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"].loc[\n",
+ " :, \"method\"\n",
+ " ] = method\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"].loc[\n",
+ " :, \"post-processing\"\n",
+ " ] = (\"energy minimization\" if config == \"_relaxed\" else \"none\")\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"].loc[\n",
+ " :, \"dataset\"\n",
+ " ] = dataset\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"].loc[\n",
+ " :, \"docked_ligand_successfully_loaded\"\n",
+ " ] = (\n",
+ " True\n",
+ " if dataset == \"casp15\"\n",
+ " else globals()[\n",
+ " f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"\n",
+ " ][[\"mol_pred_loaded\", \"mol_true_loaded\", \"mol_cond_loaded\"]].all(axis=1)\n",
+ " )\n",
+ "\n",
+ " if dataset == \"posebusters_benchmark\":\n",
+ " # keep only the results for complexes deposited in the PDB after the maximum cutoff date for any method's training data\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"][\n",
+ " \"pdb_id\"\n",
+ " ] = globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"][\n",
+ " \"mol_id\"\n",
+ " ].map(\n",
+ " lambda x: x.lower().split(\"_\")[0]\n",
+ " )\n",
+ " globals()[\n",
+ " f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"\n",
+ " ] = globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"][\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"][\n",
+ " \"pdb_id\"\n",
+ " ].isin(pb_pdb_id_deposition_date_mapping.keys())\n",
+ " ]"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Define helper functions"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "def assign_method_index(method: str) -> str:\n",
+ " \"\"\"\n",
+ " Assign method index for plotting.\n",
+ "\n",
+ " :param method: Method name.\n",
+ " :return: Method index.\n",
+ " \"\"\"\n",
+ " return list(method_mapping.keys()).index(method)\n",
+ "\n",
+ "\n",
+ "def categorize_method(method: str) -> str:\n",
+ " \"\"\"\n",
+ " Categorize method for plotting.\n",
+ "\n",
+ " :param method: Method name.\n",
+ " :return: Method category.\n",
+ " \"\"\"\n",
+ " return method_category_mapping.get(method, \"Misc\")\n",
+ "\n",
+ "\n",
+ "def subset_counter(\n",
+ " subset_counter: Counter, superset_counter: Counter, normalize_subset: bool = False\n",
+ ") -> Counter:\n",
+ " \"\"\"\n",
+ " Subset a superset counter by a subset counter.\n",
+ "\n",
+ " :param subset_counter: Subset counter.\n",
+ " :param superset_counter: Superset counter.\n",
+ " :param normalize_subset: Normalize subset counter by superset counter.\n",
+ " :return: Subsetted counter.\n",
+ " \"\"\"\n",
+ " subsetted_counter = Counter()\n",
+ " for key in subset_counter:\n",
+ " if key in superset_counter and superset_counter[key] != 0:\n",
+ " subsetted_counter[key] = (\n",
+ " subset_counter[key] / superset_counter[key]\n",
+ " if normalize_subset\n",
+ " else superset_counter[key]\n",
+ " )\n",
+ " else:\n",
+ " subsetted_counter[key] = 0 # or handle as needed\n",
+ " return subsetted_counter"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Standardize metrics"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "# load and organize the results CSVs\n",
+ "for repeat_index in range(1, max_num_repeats_per_method + 1):\n",
+ " globals()[f\"results_table_{repeat_index}\"] = pd.concat(\n",
+ " [\n",
+ " globals()[f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\"]\n",
+ " for dataset in datasets\n",
+ " for method in baseline_methods\n",
+ " for config in [\"\"]\n",
+ " if f\"{method}_{dataset}{config}_bust_results_table_{repeat_index}\" in globals()\n",
+ " ]\n",
+ " )\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"method_category\"] = globals()[\n",
+ " f\"results_table_{repeat_index}\"\n",
+ " ][\"method\"].apply(categorize_method)\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"method_assignment_index\"] = globals()[\n",
+ " f\"results_table_{repeat_index}\"\n",
+ " ][\"method\"].apply(assign_method_index)\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"crmsd_within_threshold\"] = (\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"crmsd_≤_1å\"].fillna(False)\n",
+ " )\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"rmsd_within_threshold\"] = (\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"rmsd_≤_2å\"].fillna(False)\n",
+ " )\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"rmsd_within_threshold_and_pb_valid\"] = (\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"rmsd_within_threshold\"]\n",
+ " ) & (globals()[f\"results_table_{repeat_index}\"].loc[:, \"pb_valid\"].fillna(False))\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"RMSD ≤ 2 Å & PB-Valid\"] = (\n",
+ " globals()[f\"results_table_{repeat_index}\"]\n",
+ " .loc[:, \"rmsd_within_threshold_and_pb_valid\"]\n",
+ " .astype(int)\n",
+ " )\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"cRMSD ≤ 1 Å\"] = (\n",
+ " globals()[f\"results_table_{repeat_index}\"]\n",
+ " .loc[:, \"crmsd_within_threshold\"]\n",
+ " .fillna(False)\n",
+ " .astype(int)\n",
+ " )\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"RMSD ≤ 2 Å\"] = (\n",
+ " globals()[f\"results_table_{repeat_index}\"]\n",
+ " .loc[:, \"rmsd_within_threshold\"]\n",
+ " .fillna(False)\n",
+ " .astype(int)\n",
+ " )\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"dataset\"] = (\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"dataset\"].map(dataset_mapping)\n",
+ " )\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"method\"] = (\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"method\"].map(method_mapping)\n",
+ " )"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Collect metadata across all datasets"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "# find PDB IDs of complexes across all datasets\n",
+ "for dataset in datasets:\n",
+ " for repeat_index in range(1, max_num_repeats_per_method + 1):\n",
+ " dataset_results_table = globals()[f\"results_table_{repeat_index}\"].loc[\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"dataset\"]\n",
+ " == dataset_mapping[dataset]\n",
+ " ]\n",
+ "\n",
+ " if dataset == \"casp15\":\n",
+ " dataset_results_table.loc[:, \"pdb_id\"] = dataset_results_table.loc[:, \"target\"].map(\n",
+ " casp15_target_pdb_id_mapping\n",
+ " )\n",
+ "\n",
+ " globals()[f\"{dataset}_complexes_{repeat_index}\"] = set(\n",
+ " dataset_results_table.loc[:, \"pdb_id\"].unique()\n",
+ " )"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Plot distribution of complex types across all datasets"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "# plot functional keyword statistics of the complexes across all datasets\n",
+ "pdb_info_cache = dict()\n",
+ "\n",
+ "for repeat_index in [1]: # NOTE: we only consider the first repeat\n",
+ " all_complexes_df = []\n",
+ " for dataset in datasets:\n",
+ " complexes_df = pd.DataFrame(\n",
+ " globals()[f\"{dataset}_complexes_{repeat_index}\"], columns=[\"pdb_id\"]\n",
+ " )\n",
+ " complexes_df[\"dataset\"] = dataset_mapping[dataset]\n",
+ " all_complexes_df.append(complexes_df)\n",
+ " all_complexes_df = pd.concat(all_complexes_df, ignore_index=True)\n",
+ "\n",
+ " if all_complexes_df.empty:\n",
+ " print(\"No complexes for any dataset.\")\n",
+ " continue\n",
+ "\n",
+ " complex_function_annotations = []\n",
+ " for pdb_id in set(all_complexes_df[\"pdb_id\"]):\n",
+ " pdb_id = pdb_id.lower().split(\"_\")[0]\n",
+ " if pdb_id == \"?\":\n",
+ " continue\n",
+ " if pdb_id in pdb_info_cache:\n",
+ " pdb_id_info = pdb_info_cache[pdb_id]\n",
+ " else:\n",
+ " pdb_id_info = pypdb.get_all_info(pdb_id)\n",
+ " pdb_info_cache[pdb_id] = pdb_id_info\n",
+ " if not pdb_id_info:\n",
+ " continue\n",
+ " complex_function_annotations.append(\n",
+ " # NOTE: these represent functional keywords\n",
+ " pdb_id_info[\"struct_keywords\"][\"pdbx_keywords\"]\n",
+ " .lower()\n",
+ " .split(\", \")[0]\n",
+ " )\n",
+ "\n",
+ " complex_function_annotation_counts = Counter(complex_function_annotations)\n",
+ " df = pd.DataFrame(\n",
+ " complex_function_annotation_counts.items(),\n",
+ " columns=[\"Keyword\", \"Frequency\"],\n",
+ " )\n",
+ " df[\"Frequency\"] = df[\"Frequency\"].astype(int)\n",
+ " df = df.sort_values(by=\"Frequency\", ascending=False)\n",
+ "\n",
+ " plt.figure(figsize=(20, 10))\n",
+ " sns.barplot(data=df, x=\"Frequency\", y=\"Keyword\", palette=\"viridis\")\n",
+ "\n",
+ " max_freq = df[\"Frequency\"].max()\n",
+ " plt.xticks(ticks=range(0, max_freq + 1), labels=range(0, max_freq + 1), rotation=60)\n",
+ "\n",
+ " plt.xlabel(\"Frequency\")\n",
+ " plt.ylabel(\"Complex Annotation\")\n",
+ "\n",
+ " plt.tight_layout()\n",
+ " plt.savefig(f\"complexes_functional_keywords_{repeat_index}.png\", bbox_inches=\"tight\")\n",
+ " plt.show()\n",
+ "\n",
+ " plt.close(\"all\")\n",
+ "\n",
+ " print(f\"{len(complex_function_annotations)} complex annotations across all datasets.\")"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Plot distribution of the PoseBusters Benchmark dataset's complex deposition dates"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "# # report the PDB deposition date of each PoseBusters Benchmark complex\n",
+ "# posebusters_complex_deposition_dates = dict()\n",
+ "# for pdb_id in set(\n",
+ "# all_complexes_df[all_complexes_df[\"dataset\"] == \"Posebusters Benchmark set\"][\"pdb_id\"]\n",
+ "# ):\n",
+ "# pdb_id = pdb_id.lower().split(\"_\")[0]\n",
+ "# if pdb_id == \"?\":\n",
+ "# continue\n",
+ "# if pdb_id in pdb_info_cache:\n",
+ "# pdb_id_info = pdb_info_cache[pdb_id]\n",
+ "# else:\n",
+ "# pdb_id_info = pypdb.get_all_info(pdb_id)\n",
+ "# pdb_info_cache[pdb_id] = pdb_id_info\n",
+ "# if not pdb_id_info:\n",
+ "# continue\n",
+ "# posebusters_complex_deposition_dates[pdb_id] = pdb_id_info[\"rcsb_accession_info\"][\n",
+ "# \"deposit_date\"\n",
+ "# ]\n",
+ "\n",
+ "# # analyze and plot statistics of the PoseBusters complexes' deposition dates\n",
+ "# posebusters_complex_pdb_deposition_dates_df = pd.DataFrame(\n",
+ "# {\n",
+ "# \"PDB ID\": posebusters_complex_deposition_dates.keys(),\n",
+ "# \"Deposition Date\": posebusters_complex_deposition_dates.values(),\n",
+ "# }\n",
+ "# )\n",
+ "# posebusters_complex_pdb_deposition_dates_df[\"Deposition Date\"] = pd.to_datetime(\n",
+ "# posebusters_complex_pdb_deposition_dates_df[\"Deposition Date\"]\n",
+ "# )\n",
+ "# posebusters_complex_pdb_deposition_dates_df.to_csv(\n",
+ "# \"posebusters_benchmark_complex_pdb_deposition_dates.csv\", index=False\n",
+ "# )\n",
+ "\n",
+ "# posebusters_pre_cutoff_complexes = posebusters_complex_pdb_deposition_dates_df[\n",
+ "# posebusters_complex_pdb_deposition_dates_df[\"Deposition Date\"]\n",
+ "# <= method_max_training_cutoff_date\n",
+ "# ]\n",
+ "# posebusters_post_cutoff_complexes = posebusters_complex_pdb_deposition_dates_df[\n",
+ "# posebusters_complex_pdb_deposition_dates_df[\"Deposition Date\"]\n",
+ "# > method_max_training_cutoff_date\n",
+ "# ]\n",
+ "# print(\n",
+ "# f\"{len(posebusters_pre_cutoff_complexes)}/{len(posebusters_complex_pdb_deposition_dates_df)} PoseBusters Benchmark complexes deposited before maximum cutoff of {method_max_training_cutoff_date}.\"\n",
+ "# )\n",
+ "# print(\n",
+ "# f\"{len(posebusters_post_cutoff_complexes)}/{len(posebusters_complex_pdb_deposition_dates_df)} PoseBusters Benchmark complexes deposited after maximum cutoff of {method_max_training_cutoff_date}.\"\n",
+ "# )\n",
+ "\n",
+ "# sns.histplot(posebusters_complex_pdb_deposition_dates_df[\"Deposition Date\"].values, bins=25)\n",
+ "# plt.xlabel(\"Deposition Date\")\n",
+ "# plt.xticks(rotation=45)\n",
+ "# plt.tight_layout()\n",
+ "# plt.savefig(\"posebusters_benchmark_complex_pdb_deposition_dates.png\")\n",
+ "# plt.show()\n",
+ "# plt.close(\"all\")"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Identify failure modes across all datasets"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "# find PDB IDs of complexes for which the correct (e.g., RMSD ≤ 2 Å & PB-Valid) binding conformation was not found by any method\n",
+ "for dataset in datasets:\n",
+ " docking_success_column = \"RMSD ≤ 2 Å & PB-Valid\"\n",
+ "\n",
+ " for repeat_index in range(1, max_num_repeats_per_method + 1):\n",
+ " dataset_results_table = globals()[f\"results_table_{repeat_index}\"].loc[\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"dataset\"]\n",
+ " == dataset_mapping[dataset]\n",
+ " ]\n",
+ "\n",
+ " if dataset == \"casp15\":\n",
+ " dataset_results_table.loc[:, \"pdb_id\"] = dataset_results_table.loc[:, \"target\"].map(\n",
+ " casp15_target_pdb_id_mapping\n",
+ " )\n",
+ "\n",
+ " globals()[f\"{dataset}_complexes_docked_by_any_method_{repeat_index}\"] = set(\n",
+ " dataset_results_table.loc[\n",
+ " (dataset_results_table.loc[:, docking_success_column]).astype(bool),\n",
+ " \"pdb_id\",\n",
+ " ].unique()\n",
+ " )\n",
+ " globals()[f\"{dataset}_complexes_not_docked_by_any_method_{repeat_index}\"] = set(\n",
+ " dataset_results_table.loc[\n",
+ " ~dataset_results_table.loc[:, \"pdb_id\"].isin(\n",
+ " globals()[f\"{dataset}_complexes_docked_by_any_method_{repeat_index}\"]\n",
+ " ),\n",
+ " \"pdb_id\",\n",
+ " ].unique()\n",
+ " )"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Find commonalities among the failure modes of each dataset"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "# plot functional keyword statistics of the failed complexes across all datasets\n",
+ "for repeat_index in [1]: # NOTE: for now, we only consider the first repeat\n",
+ " all_failed_complexes_df = []\n",
+ " for dataset in datasets:\n",
+ " predicted_complexes_df = pd.DataFrame(\n",
+ " globals()[f\"{dataset}_complexes_not_docked_by_any_method_{repeat_index}\"],\n",
+ " columns=[\"pdb_id\"],\n",
+ " )\n",
+ " predicted_complexes_df[\"dataset\"] = dataset_mapping[dataset]\n",
+ " all_failed_complexes_df.append(predicted_complexes_df)\n",
+ " all_failed_complexes_df = pd.concat(all_failed_complexes_df, ignore_index=True)\n",
+ "\n",
+ " if all_failed_complexes_df.empty:\n",
+ " print(\"No failed complexes for any dataset.\")\n",
+ " continue\n",
+ "\n",
+ " failed_complex_function_annotations = []\n",
+ " for pdb_id in set(all_failed_complexes_df[\"pdb_id\"]):\n",
+ " pdb_id = pdb_id.lower().split(\"_\")[0]\n",
+ " if pdb_id == \"?\":\n",
+ " continue\n",
+ " if pdb_id in pdb_info_cache:\n",
+ " pdb_id_info = pdb_info_cache[pdb_id]\n",
+ " else:\n",
+ " pdb_id_info = pypdb.get_all_info(pdb_id)\n",
+ " pdb_info_cache[pdb_id] = pdb_id_info\n",
+ " if not pdb_id_info:\n",
+ " continue\n",
+ " failed_complex_function_annotations.append(\n",
+ " # NOTE: these represent functional keywords\n",
+ " pdb_id_info[\"struct_keywords\"][\"pdbx_keywords\"]\n",
+ " .lower()\n",
+ " .split(\", \")[0]\n",
+ " )\n",
+ "\n",
+ " failed_complex_function_annotation_counts = subset_counter(\n",
+ " Counter(failed_complex_function_annotations),\n",
+ " complex_function_annotation_counts,\n",
+ " normalize_subset=True,\n",
+ " )\n",
+ " df = pd.DataFrame(\n",
+ " failed_complex_function_annotation_counts.items(),\n",
+ " columns=[\"Keyword\", \"Failed Ratio\"],\n",
+ " )\n",
+ " df[\"Frequency\"] = df[\"Keyword\"].map(complex_function_annotation_counts)\n",
+ " df.sort_values(\n",
+ " by=[\"Failed Ratio\", \"Frequency\"], ascending=False, inplace=True, ignore_index=True\n",
+ " )\n",
+ "\n",
+ " plt.figure(figsize=(10, 6))\n",
+ " sns.barplot(data=df, x=\"Failed Ratio\", y=\"Keyword\", palette=\"viridis\")\n",
+ "\n",
+ " plt.xlabel(\"Failed Ratio\")\n",
+ " plt.ylabel(\"Complex Annotation\")\n",
+ "\n",
+ " plt.xlim(0, 1.1)\n",
+ "\n",
+ " # annotate bars with the frequency of each keyword\n",
+ " for index, row in df.iterrows():\n",
+ " plt.text(\n",
+ " x=row[\"Failed Ratio\"] + 0.01,\n",
+ " y=index,\n",
+ " s=f\"{row['Failed Ratio']:.2f} ({row['Frequency']})\",\n",
+ " va=\"center\",\n",
+ " )\n",
+ "\n",
+ " plt.tight_layout()\n",
+ " plt.savefig(f\"failed_complexes_functional_keywords_{repeat_index}.png\")\n",
+ " plt.show()\n",
+ "\n",
+ " plt.close(\"all\")\n",
+ "\n",
+ " print(f\"{len(failed_complex_function_annotations)} complex annotations across all datasets.\")"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Identify AlphaFold 3's failure modes"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "# find complexes that AlphaFold 3 failed to correctly predict\n",
+ "for dataset in datasets:\n",
+ " docking_success_column = \"RMSD ≤ 2 Å & PB-Valid\"\n",
+ "\n",
+ " for repeat_index in range(1, max_num_repeats_per_method + 1):\n",
+ " dataset_results_table = globals()[f\"results_table_{repeat_index}\"].loc[\n",
+ " (\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"dataset\"]\n",
+ " == dataset_mapping[dataset]\n",
+ " )\n",
+ " & (globals()[f\"results_table_{repeat_index}\"].loc[:, \"method\"] == \"AF3\")\n",
+ " ]\n",
+ "\n",
+ " if dataset == \"casp15\":\n",
+ " dataset_results_table.loc[:, \"pdb_id\"] = dataset_results_table.loc[:, \"target\"].map(\n",
+ " casp15_target_pdb_id_mapping\n",
+ " )\n",
+ "\n",
+ " globals()[f\"{dataset}_complexes_docked_by_af3_{repeat_index}\"] = set(\n",
+ " dataset_results_table.loc[\n",
+ " (dataset_results_table.loc[:, docking_success_column]).astype(bool),\n",
+ " \"pdb_id\",\n",
+ " ].unique()\n",
+ " )\n",
+ " globals()[f\"{dataset}_complexes_not_docked_by_af3_{repeat_index}\"] = set(\n",
+ " dataset_results_table.loc[\n",
+ " ~dataset_results_table.loc[:, \"pdb_id\"].isin(\n",
+ " globals()[f\"{dataset}_complexes_docked_by_af3_{repeat_index}\"]\n",
+ " ),\n",
+ " \"pdb_id\",\n",
+ " ].unique()\n",
+ " )"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Record and plot AlphaFold 3's failure mode metadata"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "# plot functional keyword statistics of AlphaFold 3's failed complexes across all datasets\n",
+ "all_failed_af3_complexes_df = []\n",
+ "for dataset in datasets:\n",
+ " for repeat_index in [1]: # NOTE: for now, we only consider the first repeat\n",
+ " failed_af3_complexes_df = pd.DataFrame(\n",
+ " globals()[f\"{dataset}_complexes_not_docked_by_af3_{repeat_index}\"],\n",
+ " columns=[\"pdb_id\"],\n",
+ " )\n",
+ " failed_af3_complexes_df[\"dataset\"] = dataset_mapping[dataset]\n",
+ " failed_af3_complexes_df[\"repeat_index\"] = repeat_index\n",
+ " all_failed_af3_complexes_df.append(failed_af3_complexes_df)\n",
+ "all_failed_af3_complexes_df = pd.concat(all_failed_af3_complexes_df, ignore_index=True)\n",
+ "\n",
+ "failed_af3_complex_function_annotations = []\n",
+ "for pdb_id in set(all_failed_af3_complexes_df[\"pdb_id\"]):\n",
+ " pdb_id = pdb_id.lower().split(\"_\")[0]\n",
+ " if pdb_id == \"?\":\n",
+ " continue\n",
+ " if pdb_id in pdb_info_cache:\n",
+ " pdb_id_info = pdb_info_cache[pdb_id]\n",
+ " else:\n",
+ " pdb_id_info = pypdb.get_all_info(pdb_id)\n",
+ " pdb_info_cache[pdb_id] = pdb_id_info\n",
+ " if not pdb_id_info:\n",
+ " continue\n",
+ " failed_af3_complex_function_annotations.append(\n",
+ " # NOTE: these represent functional keywords\n",
+ " pdb_id_info[\"struct_keywords\"][\"pdbx_keywords\"]\n",
+ " .lower()\n",
+ " .split(\", \")[0]\n",
+ " )\n",
+ "\n",
+ "failed_af3_complex_function_annotation_counts = subset_counter(\n",
+ " Counter(failed_af3_complex_function_annotations),\n",
+ " complex_function_annotation_counts,\n",
+ " normalize_subset=True,\n",
+ ")\n",
+ "df = pd.DataFrame(\n",
+ " failed_af3_complex_function_annotation_counts.items(),\n",
+ " columns=[\"Keyword\", \"Failed Ratio\"],\n",
+ ")\n",
+ "df[\"Frequency\"] = df[\"Keyword\"].map(complex_function_annotation_counts)\n",
+ "df.sort_values(by=[\"Failed Ratio\", \"Frequency\"], ascending=False, inplace=True, ignore_index=True)\n",
+ "\n",
+ "plt.figure(figsize=(12, 8))\n",
+ "sns.barplot(data=df, x=\"Failed Ratio\", y=\"Keyword\", palette=\"viridis\")\n",
+ "\n",
+ "plt.xlabel(\"Failed Ratio\")\n",
+ "plt.ylabel(\"Complex Annotation\")\n",
+ "\n",
+ "plt.xlim(0, 1.09)\n",
+ "\n",
+ "# annotate bars with the frequency of each keyword\n",
+ "for index, row in df.iterrows():\n",
+ " plt.text(\n",
+ " x=row[\"Failed Ratio\"] + 0.01,\n",
+ " y=index,\n",
+ " s=f\"{row['Failed Ratio']:.2f} ({row['Frequency']})\",\n",
+ " va=\"center\",\n",
+ " )\n",
+ "\n",
+ "plt.tight_layout()\n",
+ "plt.savefig(\"failed_af3_complexes_functional_keywords.png\")\n",
+ "plt.show()\n",
+ "\n",
+ "plt.close(\"all\")\n",
+ "\n",
+ "print(f\"{len(failed_af3_complex_function_annotations)} complex annotations across all datasets.\")"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Study PDB statistics of different types of complexes"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "# combine all CSV files from a custom PDB report\n",
+ "report_types = os.listdir(\"pdb_reports\")\n",
+ "\n",
+ "for report_type in report_types:\n",
+ " pdb_report_dir = os.path.join(\"pdb_reports\", report_type)\n",
+ " pdb_report_files = [\n",
+ " os.path.join(pdb_report_dir, f) for f in os.listdir(pdb_report_dir) if f.endswith(\".csv\")\n",
+ " ]\n",
+ "\n",
+ " pdb_report_dfs = []\n",
+ " for pdb_report_file in pdb_report_files:\n",
+ " pdb_report_dfs.append(pd.read_csv(pdb_report_file, skiprows=1))\n",
+ " pdb_report_df = pd.concat(pdb_report_dfs, ignore_index=True)\n",
+ "\n",
+ " # analyze and plot statistics of the custom PDB report\n",
+ " pdb_report_df[\"Refinement Resolution (Å)\"] = pdb_report_df[\"Refinement Resolution (Å)\"].astype(\n",
+ " str\n",
+ " )\n",
+ " pdb_report_df[\"Refinement Resolution (Å)\"] = pd.to_numeric(\n",
+ " pdb_report_df[\"Refinement Resolution (Å)\"].str.replace(\",\", \"\"),\n",
+ " errors=\"coerce\",\n",
+ " )\n",
+ " pdb_report_df[\"Deposition Date\"] = pd.to_datetime(pdb_report_df[\"Deposition Date\"])\n",
+ "\n",
+ " pdb_report_df.to_csv(f\"{report_type}_pdb_report.csv\", index=False)\n",
+ "\n",
+ " print(f\"{len(pdb_report_df)} PDB entries in the custom {report_type} report.\")\n",
+ "\n",
+ " sns.histplot(pdb_report_df[\"Refinement Resolution (Å)\"].values)\n",
+ " plt.xlim(0, 10)\n",
+ " plt.xlabel(\"Refinement Resolution (Å)\")\n",
+ " plt.tight_layout()\n",
+ " plt.savefig(f\"{report_type}_pdb_report_resolution.png\")\n",
+ " plt.show()\n",
+ "\n",
+ " plt.close(\"all\")\n",
+ "\n",
+ " sns.histplot(pdb_report_df[\"Deposition Date\"].values)\n",
+ " plt.xlabel(\"Deposition Date\")\n",
+ " plt.tight_layout()\n",
+ " plt.savefig(f\"{report_type}_pdb_report_deposition_date.png\")\n",
+ " plt.show()\n",
+ "\n",
+ " plt.close(\"all\")"
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ ""
+ ]
+ },
+ {
+ "cell_type": "markdown",
+ "metadata": {},
+ "source": [
+ "#### Plot correlation between performance of method predictions for PoseBusters Benchmark set complexes and their maximum similarity to the PDB"
+ ]
+ },
+ {
+ "cell_type": "code",
+ "execution_count": null,
+ "metadata": {},
+ "outputs": [],
+ "source": [
+ "# compare max (training set) ligand-binding pocket structural overlap and (test set) RMSD of each method's predicted PoseBusters Benchmark set complexes\n",
+ "af3_overlap_datasets = [\"posebusters_benchmark\"]\n",
+ "\n",
+ "all_predicted_complexes_df = []\n",
+ "for dataset in af3_overlap_datasets:\n",
+ " for repeat_index in [1]: # NOTE: for now, we only consider the first repeat\n",
+ " predicted_complexes_df = copy.deepcopy(\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[\n",
+ " (\n",
+ " globals()[f\"results_table_{repeat_index}\"].loc[:, \"dataset\"]\n",
+ " == dataset_mapping[dataset]\n",
+ " )\n",
+ " ]\n",
+ " )\n",
+ " predicted_complexes_df[\"dataset\"] = dataset_mapping[dataset]\n",
+ " predicted_complexes_df[\"repeat_index\"] = repeat_index\n",
+ " all_predicted_complexes_df.append(predicted_complexes_df)\n",
+ "all_predicted_complexes_df = pd.concat(all_predicted_complexes_df, ignore_index=True)\n",
+ "all_predicted_complex_pdb_ids = list(all_predicted_complexes_df.loc[:, \"pdb_id\"].unique())\n",
+ "\n",
+ "# analyze and plot statistics of each method's predictions and the novelty of the target binding modes\n",
+ "pb_pdb_id_ccd_code_mapping = {\n",
+ " pdb_ccd_code.split(\"_\")[0]: pdb_ccd_code.split(\"_\")[1]\n",
+ " for pdb_ccd_code in os.listdir(os.path.join(\"..\", \"data\", \"posebusters_benchmark_set\"))\n",
+ " if os.path.isdir(os.path.join(\"..\", \"data\", \"posebusters_benchmark_set\", pdb_ccd_code))\n",
+ " if pdb_ccd_code.split(\"_\")[0].lower() in all_predicted_complex_pdb_ids\n",
+ " and not any(s in pdb_ccd_code for s in [\"plots\", \"msas\", \"structures\"])\n",
+ "}\n",
+ "\n",
+ "# load annotations from CSV\n",
+ "annotated_df = pd.read_csv(os.path.join(\"..\", \"data\", \"plinder\", \"annotations.csv\"))\n",
+ "annotated_df[\"target_release_date\"] = pd.to_datetime(annotated_df[\"target_release_date\"])\n",
+ "\n",
+ "# filter annotated_df to rows where (entry_pdb_id, ligand_ccd_code) matches pb_pdb_id_ccd_code_mapping\n",
+ "annotated_df = annotated_df[\n",
+ " annotated_df.apply(\n",
+ " lambda row: (\n",
+ " (row[\"entry_pdb_id\"].upper(), row[\"ligand_ccd_code\"])\n",
+ " in pb_pdb_id_ccd_code_mapping.items()\n",
+ " )\n",
+ " and not pd.isna(row[\"target_system\"]),\n",
+ " axis=1,\n",
+ " )\n",
+ "]\n",
+ "\n",
+ "# ensure the key columns match in format\n",
+ "predicted_complexes_df[\"pdb_id\"] = predicted_complexes_df[\"pdb_id\"].str.upper()\n",
+ "annotated_df[\"entry_pdb_id\"] = annotated_df[\"entry_pdb_id\"].str.upper()\n",
+ "\n",
+ "# merge RMSD values into annotated_df\n",
+ "annotated_df = annotated_df.merge(\n",
+ " predicted_complexes_df[[\"pdb_id\", \"method\", \"rmsd\"]],\n",
+ " left_on=\"entry_pdb_id\",\n",
+ " right_on=\"pdb_id\",\n",
+ " how=\"left\",\n",
+ ")\n",
+ "\n",
+ "\n",
+ "def remove_rmsd_outliers(df: pd.DataFrame, col: str = \"rmsd\", factor: float = 1.5) -> pd.DataFrame:\n",
+ " \"\"\"Remove outliers from a DataFrame column.\"\"\"\n",
+ " q1 = df[col].quantile(0.25)\n",
+ " q3 = df[col].quantile(0.75)\n",
+ " iqr = q3 - q1\n",
+ " lower_bound = q1 - factor * iqr\n",
+ " upper_bound = q3 + factor * iqr\n",
+ " return df[(df[col] >= lower_bound) & (df[col] <= upper_bound)]\n",
+ "\n",
+ "\n",
+ "# drop rows with missing or outlier values\n",
+ "method_generalization_df = annotated_df[[\"sucos_shape_pocket_qcov\", \"method\", \"rmsd\"]].dropna()\n",
+ "method_generalization_df = remove_rmsd_outliers(method_generalization_df)\n",
+ "\n",
+ "# --- compute per-method correlations (use all points for stats) ---\n",
+ "method_corrs = []\n",
+ "for method_name, df_method in method_generalization_df.groupby(\"method\"):\n",
+ " if len(df_method) < 3:\n",
+ " continue\n",
+ " pr, pp = pearsonr(df_method[\"sucos_shape_pocket_qcov\"], df_method[\"rmsd\"])\n",
+ " sr, sp = spearmanr(df_method[\"sucos_shape_pocket_qcov\"], df_method[\"rmsd\"])\n",
+ " method_corrs.append(\n",
+ " {\n",
+ " \"method\": method_name,\n",
+ " \"pearson_r\": pr,\n",
+ " \"pearson_p\": pp,\n",
+ " \"spearman_r\": sr,\n",
+ " \"spearman_p\": sp,\n",
+ " \"n\": len(df_method),\n",
+ " }\n",
+ " )\n",
+ "\n",
+ "corr_df = pd.DataFrame(method_corrs)\n",
+ "if corr_df.empty:\n",
+ " raise ValueError(\"No methods have >= 3 points; nothing to plot.\")\n",
+ "\n",
+ "# --- split positive vs negative Pearson r ---\n",
+ "# pos_df = corr_df[corr_df[\"pearson_r\"] >= 0].sort_values(\"pearson_r\", ascending=False)\n",
+ "# neg_df = corr_df[corr_df[\"pearson_r\"] < 0].sort_values(\"pearson_r\")\n",
+ "\n",
+ "neg_df = corr_df.sort_values(\"pearson_r\")\n",
+ "\n",
+ "# pos_methods = pos_df[\"method\"].tolist()\n",
+ "neg_methods = neg_df[\"method\"].tolist()\n",
+ "\n",
+ "# --- determine clipping to ignore extreme RMSD values for axis scaling ---\n",
+ "ymax = np.percentile(method_generalization_df[\"rmsd\"], 95)\n",
+ "ymin = max(0.0, method_generalization_df[\"rmsd\"].min())\n",
+ "\n",
+ "# fig, axes = plt.subplots(1, 2, figsize=(14, 6), sharey=True)\n",
+ "# ax_pos, ax_neg = axes\n",
+ "\n",
+ "fig, axes = plt.subplots(1, 1, figsize=(10, 6), sharey=True)\n",
+ "ax_neg = axes\n",
+ "\n",
+ "\n",
+ "def plot_group(ax, methods, corr_subdf):\n",
+ " if not methods:\n",
+ " ax.text(0.5, 0.5, \"No methods in this group\", ha=\"center\", va=\"center\")\n",
+ " ax.set_xlabel(\"SuCOS-pocket similarity\")\n",
+ " ax.set_ylim(ymin, ymax)\n",
+ " return\n",
+ "\n",
+ " palette = sns.color_palette(n_colors=len(methods))\n",
+ " for i, method in enumerate(methods):\n",
+ " dfm = method_generalization_df[method_generalization_df[\"method\"] == method]\n",
+ " color = palette[i]\n",
+ " # scatter points\n",
+ " sns.scatterplot(\n",
+ " data=dfm,\n",
+ " x=\"sucos_shape_pocket_qcov\",\n",
+ " y=\"rmsd\",\n",
+ " ax=ax,\n",
+ " label=method,\n",
+ " color=color,\n",
+ " alpha=0.5,\n",
+ " s=40,\n",
+ " )\n",
+ " # regression line (no scatter here)\n",
+ " sns.regplot(\n",
+ " data=dfm,\n",
+ " x=\"sucos_shape_pocket_qcov\",\n",
+ " y=\"rmsd\",\n",
+ " ax=ax,\n",
+ " scatter=False,\n",
+ " ci=None,\n",
+ " color=color,\n",
+ " line_kws={\"lw\": 2},\n",
+ " )\n",
+ " # mark outliers that were clipped for axis scaling\n",
+ " out = dfm[dfm[\"rmsd\"] > ymax]\n",
+ " if not out.empty:\n",
+ " ax.scatter(\n",
+ " out[\"sucos_shape_pocket_qcov\"],\n",
+ " [ymax] * len(out),\n",
+ " marker=\"^\",\n",
+ " s=60,\n",
+ " edgecolor=\"k\",\n",
+ " linewidth=0.5,\n",
+ " color=color,\n",
+ " alpha=0.85,\n",
+ " )\n",
+ "\n",
+ " ax.set_xlabel(\"SuCOS-pocket similarity\")\n",
+ " ax.set_ylim(ymin, ymax)\n",
+ " ax.legend(fontsize=8, loc=\"upper left\")\n",
+ "\n",
+ " # correlation table for this panel\n",
+ " text_lines = [\n",
+ " f\"{r['method']}: r={r['pearson_r']:.2f} (p={r['pearson_p']:.1g}), ρ={r['spearman_r']:.2f}\"\n",
+ " for _, r in corr_subdf.iterrows()\n",
+ " ]\n",
+ " ax.text(\n",
+ " 0.98,\n",
+ " 0.98, # near top-right\n",
+ " \"\\n\".join(text_lines),\n",
+ " fontsize=9,\n",
+ " ha=\"right\",\n",
+ " va=\"top\",\n",
+ " transform=ax.transAxes, # position in axes coordinates\n",
+ " bbox=dict(facecolor=\"white\", edgecolor=\"gray\", boxstyle=\"round,pad=0.3\"),\n",
+ " )\n",
+ "\n",
+ "\n",
+ "# plot_group(ax_pos, pos_methods, pos_df)\n",
+ "# # ax_pos.set_title(\"Methods with positive Pearson r\")\n",
+ "# ax_pos.set_ylabel(\"RMSD\")\n",
+ "\n",
+ "\n",
+ "plot_group(ax_neg, neg_methods, neg_df)\n",
+ "# ax_neg.set_title(\"Methods with negative Pearson r\")\n",
+ "# ax_neg.set_ylabel(\"\") # shared y-label on left\n",
+ "ax_neg.set_ylabel(\"RMSD\")\n",
+ "\n",
+ "plt.tight_layout()\n",
+ "plt.savefig(\"posebusters_benchmark_methods_generalization_analysis.png\", dpi=300)\n",
+ "plt.show()\n",
+ "\n",
+ "# print sorted summary to console\n",
+ "print(corr_df.sort_values(\"pearson_r\", ascending=False).to_string(index=False))"
+ ]
+ }
+ ],
+ "metadata": {
+ "kernelspec": {
+ "display_name": "PoseBench",
+ "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.10.14"
+ }
+ },
+ "nbformat": 4,
+ "nbformat_minor": 2
+}
diff --git a/notebooks/immune_system_pdb_report.csv b/notebooks/immune_system_pdb_report.csv
new file mode 100644
index 00000000..cf06b16e
--- /dev/null
+++ b/notebooks/immune_system_pdb_report.csv
@@ -0,0 +1,10220 @@
+Entry ID,Deposition Date,Refinement Resolution (Å),Unnamed: 3
+1A6V,1998-03-03,1.8,
+1B09,1998-11-18,2.5,
+1B0W,1998-11-13,1.8,
+1B2W,1998-12-01,2.9,
+1B3J,1998-12-11,3.0,
+1B88,1999-02-09,2.5,
+1BAF,1992-01-16,2.9,
+1BJ1,1998-06-30,2.4,
+1BLN,1998-07-16,2.8,
+1BM3,1999-04-15,2.0,
+1BQH,1998-08-16,2.8,
+1BWM,1998-09-23,,
+1BWW,1998-09-29,1.7,
+1BX2,1998-10-12,2.6,
+1BXI,1998-10-04,2.05,
+1BXT,1998-10-08,1.85,
+1BZ7,1998-11-06,2.5,
+1C12,1999-07-20,2.6,
+1C16,1999-07-20,3.1,
+1C1E,1999-07-22,1.9,
+1C5B,1999-11-08,2.1,
+1C5C,1999-11-09,1.61,
+1C5D,1999-11-17,2.4,
+1C9H,1999-08-02,2.0,
+1CD0,1999-03-05,1.9,
+1CE1,1999-03-12,1.9,
+1CI5,1999-04-07,,
+1CL7,1999-05-06,3.0,
+1CQK,1999-08-06,2.2,
+1CQP,1999-08-10,2.6,
+1CR9,1999-08-14,2.0,
+1CT8,1999-08-20,2.2,
+1CU4,1999-08-20,2.9,
+1CV9,1999-08-23,,
+1CZ8,1999-09-01,2.4,
+1D5B,1999-10-06,2.8,
+1D5I,1999-10-07,2.0,
+1D6V,1999-10-15,2.0,
+1D6X,1999-10-15,,
+1D9C,1999-10-27,2.0,
+1D9G,1999-10-27,2.9,
+1D9K,1999-10-28,3.2,
+1DEE,1999-11-15,2.7,
+1DFW,1999-11-22,,
+1DGQ,1999-11-24,,
+1DL7,1999-12-08,2.35,
+1DN0,1999-12-15,2.28,
+1DN2,1999-12-15,2.7,
+1DQD,2000-01-04,2.1,
+1DQL,2000-01-04,2.6,
+1DQM,2000-01-04,2.1,
+1DQQ,2000-01-04,1.8,
+1DQT,2000-01-05,2.0,
+1DQY,2000-01-05,1.83,
+1DQZ,2000-01-05,1.5,
+1DR9,2000-01-06,3.0,
+1DT4,2000-01-11,2.6,
+1DTJ,2000-01-12,2.0,
+1DUY,2000-01-19,2.15,
+1DUZ,2000-01-19,1.8,
+1DZB,2000-02-23,2.0,
+1E27,2000-05-18,2.2,
+1E4J,2000-07-07,2.5,
+1E4K,2000-07-07,3.2,
+1E4W,2000-07-12,1.95,
+1E4X,2000-07-12,1.9,
+1ED3,2000-01-26,2.55,
+1EEQ,2000-02-01,1.5,
+1EEU,2000-02-03,1.6,
+1EEY,2000-02-04,2.25,
+1EEZ,2000-02-04,2.3,
+1EFQ,2000-02-09,1.6,
+1EFX,2000-02-10,3.0,
+1EGJ,2000-02-15,2.8,
+1EHL,2000-02-21,2.4,
+1EJO,2000-03-03,2.3,
+1EK3,2000-03-06,1.9,
+1EKU,2000-03-09,2.9,
+1EL0,2000-03-11,,
+1EMT,2000-03-17,2.25,
+1EMV,2000-03-20,1.7,
+1ES0,2000-04-07,2.6,
+1ET6,2000-04-12,1.9,
+1ET9,2000-04-12,1.9,
+1ETZ,2000-04-13,2.6,
+1EU3,2000-04-13,1.68,
+1EU4,2000-04-13,2.5,
+1EXU,2000-05-04,2.7,
+1F11,2000-05-18,3.0,
+1F1M,2000-05-19,1.8,
+1F2Q,2000-05-28,2.4,
+1F2X,2000-05-30,2.1,
+1F3D,2000-06-02,1.87,
+1F3J,2000-06-04,3.1,
+1F3R,2000-06-06,,
+1F4W,2000-06-10,2.3,
+1F4X,2000-06-10,2.3,
+1F4Y,2000-06-10,2.8,
+1F6A,2000-06-20,3.5,
+1F6L,2000-06-22,2.8,
+1F8T,2000-07-05,2.2,
+1F90,2000-07-06,2.6,
+1FE8,2000-07-21,2.03,
+1FG2,2000-07-27,2.754,
+1FG9,2000-07-28,2.9,
+1FGV,1993-11-01,1.9,
+1FH5,2000-07-31,2.9,
+1FJ1,2000-08-07,2.68,
+1FL3,2000-08-11,2.45,
+1FL5,2000-08-11,2.1,
+1FL6,2000-08-11,2.8,
+1FM5,2000-08-16,2.27,
+1FN4,2000-08-21,2.8,
+1FNE,2000-08-21,1.9,
+1FNG,2000-08-21,1.9,
+1FNS,2000-08-23,2.0,
+1FO0,2000-08-24,2.5,
+1FP5,2000-08-30,2.3,
+1FR2,2000-09-07,1.6,
+1FSK,2000-09-11,2.9,
+1FV1,2000-09-18,1.9,
+1FYH,2000-09-29,2.04,
+1FYT,2000-10-03,2.6,
+1FZJ,2000-10-03,1.9,
+1FZK,2000-10-03,1.7,
+1FZM,2000-10-03,1.8,
+1FZO,2000-10-03,1.8,
+1G0X,2000-10-09,2.1,
+1G0Y,2000-10-09,3.0,
+1G5Z,2000-11-02,2.51,
+1G6R,2000-11-07,2.8,
+1G7P,2000-11-13,1.5,
+1G7Q,2000-11-13,1.6,
+1G84,2000-11-16,,
+1G8Q,2000-11-20,1.6,
+1G9E,2000-11-23,,
+1GCZ,2000-08-24,1.9,
+1GD0,2000-08-24,1.5,
+1GPO,1997-03-27,1.95,
+1GYF,1999-04-30,,
+1H0T,2002-06-27,,
+1H3T,2002-09-19,2.4,
+1H3U,2002-09-19,2.4,
+1H3V,2002-09-19,3.1,
+1H3W,2002-09-19,2.85,
+1H3X,2002-09-19,2.44,
+1H3Y,2002-09-19,4.1,
+1HA6,2001-03-28,,
+1HDM,1998-09-09,2.5,
+1HH6,2000-12-21,2.6,
+1HQ4,2000-12-14,2.7,
+1HQR,2000-12-19,3.2,
+1HSB,1993-03-30,1.9,
+1HXM,2001-01-16,3.12,
+1HYR,2001-01-21,2.7,
+1HZF,2001-01-24,2.3,
+1HZH,2001-01-24,2.7,
+1I1A,2001-01-31,2.8,
+1I1C,2001-01-31,2.7,
+1I1F,1999-04-16,2.8,
+1I1Y,1999-04-16,2.2,
+1I3R,2001-02-15,2.4,
+1I3U,2001-02-16,1.95,
+1I3V,2001-02-16,2.03,
+1I4F,2001-02-21,1.4,
+1I7R,2001-03-10,2.2,
+1I7T,2001-03-10,2.8,
+1I7U,2001-03-10,1.8,
+1I7Z,2001-03-12,2.3,
+1I85,2001-03-12,3.2,
+1I8I,2001-03-14,2.4,
+1I8K,2001-03-14,1.8,
+1I8L,2001-03-14,3.0,
+1I9E,2001-03-19,2.5,
+1I9I,2001-03-20,2.72,
+1I9J,2001-03-20,2.6,
+1IBG,1994-10-25,2.7,
+1IEH,2001-04-09,,
+1IFR,2001-04-13,1.4,
+1IL1,2001-05-07,2.2,
+1IM9,2001-05-10,2.8,
+1INQ,2001-05-14,2.2,
+1IQW,2001-08-10,2.5,
+1IT9,2002-01-11,2.8,
+1IV5,2002-03-14,2.6,
+1IW2,2002-04-11,1.9,
+1J05,2002-11-01,1.5,
+1J4V,2001-11-21,,
+1J86,2001-05-20,3.2,
+1J87,2001-05-20,3.2,
+1J88,2001-05-20,3.2,
+1J89,2001-05-20,4.1,
+1J8H,2001-05-21,2.4,
+1JA3,2001-05-29,3.0,
+1JBJ,2001-06-05,,
+1JE6,2001-06-15,2.5,
+1JF1,2001-06-19,1.85,
+1JFM,2001-06-21,2.85,
+1JFQ,2001-06-21,1.9,
+1JGD,2001-06-25,1.9,
+1JGE,2001-06-25,2.1,
+1JGL,2001-06-26,2.15,
+1JGU,2001-06-26,1.8,
+1JGV,2001-06-26,1.85,
+1JHK,2001-06-28,2.51,
+1JHT,2001-06-28,2.15,
+1JK8,2001-07-11,2.4,
+1JL4,2001-07-15,4.3,
+1JN6,2001-07-23,2.7,
+1JNH,2001-07-24,2.85,
+1JNJ,2001-07-24,,
+1JNL,2001-07-24,3.0,
+1JNN,2001-07-24,3.2,
+1JNP,2001-07-24,2.5,
+1JP5,2001-08-01,2.7,
+1JPF,2001-08-02,2.18,
+1JPG,2001-08-02,2.2,
+1JPS,2001-08-03,1.85,
+1JPT,2001-08-03,1.85,
+1JPY,2001-08-03,2.85,
+1JUF,2001-08-24,2.0,
+1JVK,2001-08-30,1.94,
+1JWM,2001-09-04,2.7,
+1JWS,2001-09-05,2.6,
+1JWU,2001-09-05,2.3,
+1K2D,2001-09-26,2.2,
+1K5N,2001-10-11,1.09,
+1K6Q,2001-10-17,2.4,
+1K8D,2001-10-23,2.3,
+1K8I,2001-10-24,3.1,
+1KA6,2001-10-31,,
+1KA7,2001-10-31,,
+1KBG,1998-08-28,2.2,
+1KC5,2001-11-07,2.5,
+1KCG,2001-11-08,2.6,
+1KCR,2001-11-11,2.9,
+1KCS,2001-11-11,2.5,
+1KCU,2001-11-11,2.2,
+1KCV,2001-11-11,1.8,
+1KFA,2001-11-20,2.8,
+1KGC,2001-11-26,1.5,
+1KJ2,2001-12-04,2.71,
+1KJ3,2001-12-04,2.3,
+1KJM,2001-12-04,2.35,
+1KJV,2001-12-05,1.48,
+1KN2,2001-12-18,1.9,
+1KN4,2001-12-18,1.9,
+1KPR,2002-01-02,2.8,
+1KPU,2002-01-02,1.5,
+1KPV,2002-01-02,1.71,
+1KT2,2002-01-15,2.8,
+1KTD,2002-01-15,2.4,
+1KTK,2002-01-16,3.0,
+1KTL,2002-01-16,3.1,
+1KTR,2002-01-17,2.7,
+1KZQ,2002-02-07,1.7,
+1L0X,2002-02-14,2.8,
+1L0Y,2002-02-14,2.5,
+1L2H,2002-02-21,1.54,
+1L3H,2002-02-27,,
+1L6X,2002-03-14,1.65,
+1L7I,2002-03-15,1.8,
+1L7T,2002-03-17,2.1,
+1L8W,2002-03-21,2.3,
+1LDS,2002-04-09,1.8,
+1LEG,2002-04-09,1.75,
+1LEK,2002-04-09,2.15,
+1LF7,2002-04-10,1.2,
+1LGV,2002-04-16,1.95,
+1LHZ,2002-04-17,2.3,
+1LJT,2002-04-22,2.0,
+1LK2,2002-04-23,1.35,
+1LK3,2002-04-23,1.91,
+1LMI,2002-05-01,1.5,
+1LO0,2002-05-05,2.0,
+1LO2,2002-05-06,2.0,
+1LO3,2002-05-06,2.3,
+1LO4,2002-05-06,2.4,
+1LP1,2002-05-07,2.3,
+1LP9,2002-05-07,2.0,
+1LQS,2002-05-13,2.7,
+1LY2,2002-06-06,1.8,
+1M05,2002-06-11,1.9,
+1M4K,2002-07-03,2.3,
+1M4V,2002-07-05,1.9,
+1M6O,2002-07-17,1.6,
+1M71,2002-07-18,2.8,
+1M7D,2002-07-19,2.3,
+1M7I,2002-07-19,2.5,
+1MCC,1993-02-25,2.7,
+1MCI,1993-02-25,2.7,
+1MCL,1993-02-25,2.7,
+1MCN,1993-02-25,2.7,
+1MD6,2002-08-07,1.6,
+1MEX,2002-08-08,1.25,
+1MH5,2002-08-19,2.1,
+1MHH,2002-08-20,2.1,
+1MHP,2002-08-20,2.8,
+1MHX,2002-08-21,1.8,
+1MI0,2002-08-21,1.85,
+1MI5,2002-08-21,2.5,
+1MIE,2002-08-23,1.95,
+1MJ7,2002-08-27,2.25,
+1MJ8,2002-08-27,1.75,
+1MJJ,2002-08-28,2.1,
+1MJN,2002-08-28,1.3,
+1MJU,2002-08-28,1.22,
+1MKF,2002-08-29,2.1,
+1ML0,2002-08-29,2.8,
+1MLB,1995-03-08,2.1,
+1MNU,1999-04-30,2.5,
+1MOE,2002-09-09,2.6,
+1MPU,2002-09-12,2.5,
+1MQ8,2002-09-15,3.3,
+1MQ9,2002-09-15,2.0,
+1MQA,2002-09-15,2.5,
+1MQK,2002-09-16,1.28,
+1MUJ,2002-09-23,2.15,
+1MVF,2002-09-25,1.65,
+1MVU,2002-09-26,1.78,
+1MWA,2002-09-27,2.4,
+1N0X,2002-10-15,1.8,
+1N1F,2002-10-17,1.95,
+1N2R,2002-10-24,1.7,
+1N3N,2002-10-29,3.0,
+1N4X,2002-11-02,1.7,
+1N59,2002-11-05,2.95,
+1N5A,2002-11-05,2.85,
+1N64,2002-11-08,2.34,
+1N6U,2002-11-12,,
+1N6V,2002-11-12,,
+1N7M,2002-11-15,1.8,
+1NAK,2002-11-27,2.57,
+1NAM,2002-11-28,2.7,
+1NAN,2002-11-28,2.3,
+1NBQ,2002-12-03,2.9,
+1NC2,2002-12-04,2.1,
+1NC4,2002-12-04,2.25,
+1NCN,2002-12-05,2.7,
+1NCW,2002-12-05,1.3,
+1ND0,2002-12-05,2.45,
+1NEZ,2002-12-12,2.1,
+1NGW,2002-12-18,2.6,
+1NGX,2002-12-18,1.8,
+1NGY,2002-12-18,2.2,
+1NGZ,2002-12-18,1.6,
+1NJ9,2002-12-30,2.35,
+1NKO,2003-01-03,1.45,
+1NL0,2003-01-06,2.2,
+1NLB,2003-01-07,1.6,
+1NPU,2003-01-20,2.0,
+1NTJ,2003-01-30,,
+1NTL,2003-01-30,,
+1NYO,2003-02-13,,
+1O0V,2002-09-06,2.6,
+1OAQ,2003-01-21,1.5,
+1OAR,2003-01-21,2.23,
+1OAU,2003-01-21,1.8,
+1OAX,2003-01-21,2.67,
+1OAY,2003-01-21,2.66,
+1OAZ,2003-01-21,2.78,
+1OB1,2003-01-22,2.9,
+1OCW,2003-02-11,2.0,
+1OEY,2003-04-02,2.0,
+1OF2,2003-04-04,2.2,
+1OGT,2003-05-13,1.47,
+1ONQ,2003-02-28,2.15,
+1OQE,2003-03-07,2.5,
+1OQO,2003-03-10,2.3,
+1OQX,2003-03-11,2.6,
+1OSG,2003-03-19,3.0,
+1OSX,2003-03-20,,
+1OVZ,2003-03-27,3.0,
+1OW0,2003-03-27,3.1,
+1P1Z,2003-04-14,3.26,
+1P4B,2003-04-22,2.35,
+1P4I,2003-04-23,2.8,
+1P4L,2003-04-23,2.9,
+1P6F,2003-04-29,2.2,
+1P7E,2003-05-01,,
+1P7F,2003-05-01,,
+1P7K,2003-05-02,1.75,
+1P7Q,2003-05-05,3.4,
+1PEW,2003-05-22,1.6,
+1PG7,2003-05-27,2.5,
+1PK6,2003-06-05,1.85,
+1PKO,2003-06-06,1.45,
+1PKQ,2003-06-06,3.0,
+1POQ,2003-06-16,,
+1PPQ,2003-06-17,,
+1PSZ,1998-10-13,2.0,
+1PW3,2003-06-30,1.9,
+1PW6,2003-06-30,2.6,
+1PY2,2003-07-07,2.8,
+1PY9,2003-07-08,1.8,
+1PZ5,2003-07-09,1.8,
+1Q0X,2003-07-17,1.6,
+1Q0Y,2003-07-17,2.0,
+1Q1J,2003-07-21,2.5,
+1Q2N,2003-07-25,,
+1Q72,2003-08-15,1.7,
+1Q94,2003-08-22,2.4,
+1Q9K,2003-08-25,1.96,
+1Q9L,2003-08-25,2.28,
+1Q9O,2003-08-25,1.79,
+1Q9W,2003-08-26,1.75,
+1QA9,1999-04-13,3.2,
+1QAC,1999-02-25,1.8,
+1QD0,1999-07-08,2.5,
+1QE6,1999-07-13,2.35,
+1QFO,1999-04-12,1.85,
+1QFW,1999-04-15,3.5,
+1QKZ,1999-08-17,1.95,
+1QNZ,1999-10-26,,
+1QP1,1999-05-30,2.06,
+1QQD,1999-06-03,2.7,
+1QQF,1999-06-04,1.45,
+1QR1,1999-06-17,2.4,
+1QRN,1999-06-14,2.8,
+1QSE,1999-06-21,2.8,
+1QSF,1999-06-21,2.8,
+1QSJ,1999-06-22,1.9,
+1QVO,2003-08-28,2.22,
+1QYG,2003-09-10,1.81,
+1R24,1998-11-05,3.1,
+1R3H,2003-10-02,2.5,
+1R5I,2003-10-10,2.6,
+1R70,2003-10-17,,
+1R88,2003-10-23,1.71,
+1RD4,2003-11-05,2.4,
+1RFD,2003-11-07,2.09,
+1RHH,2003-11-14,1.9,
+1RIH,2003-11-17,2.5,
+1RIU,2003-11-18,2.0,
+1RIV,2003-11-18,2.2,
+1RJL,2003-11-19,2.6,
+1RJY,2003-11-20,1.9,
+1RJZ,2003-11-20,2.6,
+1RK0,2003-11-20,2.61,
+1RK1,2003-11-20,2.1,
+1RU9,2003-12-11,2.5,
+1RUA,2003-12-11,1.75,
+1RUK,2003-12-11,1.4,
+1RUL,2003-12-11,1.88,
+1RUM,2003-12-11,1.48,
+1RUP,2003-12-11,1.4,
+1RUQ,2003-12-11,1.86,
+1RUR,2003-12-11,1.5,
+1RZ7,2003-12-24,2.0,
+1RZ8,2003-12-24,2.3,
+1RZF,2003-12-24,1.7,
+1RZG,2003-12-24,2.0,
+1RZI,2003-12-24,2.9,
+1S3K,2004-01-13,1.9,
+1S5I,2004-01-21,2.7,
+1S7Q,2004-01-30,1.99,
+1S7R,2004-01-30,2.95,
+1S7S,2004-01-30,1.99,
+1S7T,2004-01-30,2.3,
+1S7U,2004-01-30,2.2,
+1S7V,2004-01-30,2.2,
+1S7W,2004-01-30,2.4,
+1S7X,2004-01-30,2.41,
+1S8D,2004-02-02,2.2,
+1S9V,2004-02-05,2.22,
+1S9W,2004-02-05,2.2,
+1S9X,2004-02-05,2.5,
+1S9Y,2004-02-05,2.3,
+1SBB,1999-02-22,2.4,
+1SEQ,2004-02-18,1.78,
+1SHM,2004-02-26,1.9,
+1SJE,2004-03-03,2.45,
+1SJH,2004-03-03,2.25,
+1SJX,2004-03-04,2.2,
+1SK3,2004-03-04,2.8,
+1SK4,2004-03-04,1.65,
+1SMO,2004-03-09,1.47,
+1SS1,2004-03-23,,
+1SVZ,2004-03-30,1.89,
+1SXR,2004-03-31,1.56,
+1SYS,2004-04-01,2.4,
+1SYV,2004-04-02,1.7,
+1T04,2004-04-07,3.0,
+1T0M,2004-04-12,2.0,
+1T0N,2004-04-12,1.8,
+1T0P,2004-04-12,1.66,
+1T1W,2004-04-19,2.2,
+1T1X,2004-04-19,2.2,
+1T1Y,2004-04-19,2.0,
+1T1Z,2004-04-19,1.9,
+1T20,2004-04-19,2.2,
+1T21,2004-04-19,2.19,
+1T22,2004-04-19,2.2,
+1T2J,2004-04-21,1.5,
+1T2Q,2004-04-22,1.83,
+1T3F,2004-04-26,2.0,
+1T4K,2004-04-29,2.5,
+1T4Q,2004-04-30,2.1,
+1T5W,2004-05-05,2.4,
+1T5X,2004-05-05,2.5,
+1T66,2004-05-05,2.3,
+1T83,2004-05-11,3.0,
+1T89,2004-05-11,3.5,
+1T8C,2004-05-12,,
+1T8D,2004-05-12,,
+1TOO,2004-06-14,2.1,
+1TP0,2004-06-15,2.2,
+1TVB,2004-06-29,1.8,
+1TVH,2004-06-29,1.802,
+1TWE,2004-06-30,2.1,
+1TWM,2004-07-01,2.26,
+1TY0,2004-07-06,1.75,
+1TY2,2004-07-07,2.0,
+1TZG,2004-07-09,2.2,
+1TZH,2004-07-09,2.6,
+1TZI,2004-07-10,2.8,
+1U0Q,2004-07-14,1.6,
+1U3H,2004-07-21,2.42,
+1U58,2004-07-27,1.9,
+1U6A,2004-07-29,2.81,
+1U8H,2004-08-06,2.1,
+1U8I,2004-08-06,2.0,
+1U8J,2004-08-06,2.24,
+1U8K,2004-08-06,2.24,
+1U8L,2004-08-06,2.6,
+1U8M,2004-08-06,2.4,
+1U8N,2004-08-06,2.56,
+1U8O,2004-08-06,3.02,
+1U8P,2004-08-06,3.23,
+1U8Q,2004-08-06,2.24,
+1U91,2004-08-09,2.24,
+1U92,2004-08-09,2.24,
+1U93,2004-08-09,2.37,
+1U95,2004-08-09,2.24,
+1U9K,2004-08-09,1.76,
+1UB5,2003-03-30,2.0,
+1UB6,2003-03-30,2.12,
+1UCT,2003-04-21,2.1,
+1UFU,2003-06-10,3.0,
+1UGN,2003-06-17,1.8,
+1UJZ,2003-08-13,2.1,
+1UM4,2003-09-23,1.8,
+1UM5,2003-09-23,1.6,
+1UM6,2003-09-23,1.8,
+1UVQ,2004-01-22,1.8,
+1UWX,2004-02-12,2.2,
+1UYW,2004-03-03,2.0,
+1UZ6,2004-03-05,2.05,
+1UZ8,2004-03-05,1.8,
+1VDG,2004-03-22,2.8,
+1VER,2004-04-05,2.82,
+1VES,2004-04-05,2.18,
+1VF8,2004-04-09,1.31,
+1VGK,2004-04-27,2.06,
+1VPO,2004-11-15,2.15,
+1W0V,2004-06-14,2.27,
+1W0W,2004-06-14,2.11,
+1W2R,2004-07-08,,
+1W2S,2004-07-08,,
+1W72,2004-08-27,2.15,
+1WBX,2004-11-05,1.9,
+1WBY,2004-11-05,2.3,
+1WBZ,2004-11-05,2.0,
+1WCB,2004-11-12,2.5,
+1WGL,2004-05-28,,
+1WT5,2004-11-16,2.1,
+1WWL,2005-01-06,2.5,
+1WZ1,2005-02-21,1.85,
+1X7Q,2004-08-16,1.45,
+1X9Q,2004-08-24,1.5,
+1XAU,2004-08-26,1.8,
+1XCQ,2004-09-03,3.5,
+1XCT,2004-09-03,3.05,
+1XDD,2004-09-06,2.2,
+1XDG,2004-09-06,2.1,
+1XED,2004-09-10,1.9,
+1XEE,2004-09-10,,
+1XF3,2004-09-13,2.3,
+1XF4,2004-09-13,2.5,
+1XF5,2004-09-14,2.6,
+1XGP,2004-09-17,2.1,
+1XGQ,2004-09-17,2.1,
+1XGR,2004-09-17,2.1,
+1XGT,2004-09-17,2.1,
+1XGU,2004-09-17,2.1,
+1XGY,2004-09-17,2.71,
+1XH3,2004-09-17,1.48,
+1XR8,2004-10-14,2.3,
+1XT5,2004-10-21,1.15,
+1XUO,2004-10-26,1.8,
+1XXG,2004-11-05,2.2,
+1XZ0,2004-11-11,2.8,
+1Y0L,2004-11-15,2.5,
+1Y18,2004-11-17,2.8,
+1Y6K,2004-12-06,2.52,
+1Y6M,2004-12-06,2.8,
+1Y6N,2004-12-06,2.7,
+1YC7,2004-12-22,1.6,
+1YC8,2004-12-22,2.7,
+1YCK,2004-12-22,1.7,
+1YDP,2004-12-25,1.9,
+1YEI,1998-08-13,1.9,
+1YEJ,1998-08-13,1.85,
+1YEK,1998-08-13,2.1,
+1YJG,2005-01-14,2.22,
+1YMH,2005-01-21,2.6,
+1YMM,2005-01-21,3.5,
+1YN6,2005-01-23,2.2,
+1YN7,2005-01-24,2.2,
+1YNK,2005-01-24,2.1,
+1YNL,2005-01-24,1.7,
+1YNT,2005-01-25,3.1,
+1YPO,2005-01-31,3.0,
+1YPQ,2005-01-31,1.4,
+1YPU,2005-01-31,2.05,
+1YPZ,2005-01-31,3.4,
+1YQV,2005-02-02,1.7,
+1YUH,1996-01-30,3.0,
+1YXE,2005-02-21,,
+1YY8,2005-02-24,2.0,
+1Z2K,2005-03-08,,
+1Z5L,2005-03-18,2.2,
+1Z92,2005-03-31,2.8,
+1ZA6,2005-04-05,2.8,
+1ZAN,2005-04-06,1.7,
+1ZEA,2005-04-18,1.78,
+1ZGL,2005-04-21,2.8,
+1ZHB,2005-04-25,2.7,
+1ZHK,2005-04-26,1.6,
+1ZHL,2005-04-26,1.5,
+1ZIW,2005-04-27,2.1,
+1ZS8,2005-07-22,3.0,
+1ZSD,2005-05-24,1.7,
+1ZT1,2005-05-26,2.5,
+1ZT4,2005-05-26,3.0,
+1ZT7,2005-05-26,3.0,
+1ZVO,2005-06-02,,
+1ZVS,2005-06-02,2.8,
+2A0Z,2005-06-17,2.4,
+2A1W,2005-06-21,2.7,
+2A55,2005-06-30,,
+2A6D,2005-07-02,2.9,
+2A6I,2005-07-02,2.5,
+2A6J,2005-07-02,2.7,
+2A6K,2005-07-03,3.0,
+2A73,2005-07-04,3.3,
+2A74,2005-07-04,2.4,
+2A77,2005-07-04,1.8,
+2A83,2005-07-07,1.4,
+2A9M,2005-07-12,2.1,
+2A9N,2005-07-12,3.0,
+2AAB,2005-07-13,2.5,
+2ADG,2005-07-20,2.5,
+2ADI,2005-07-20,2.8,
+2ADJ,2005-07-20,2.9,
+2AEP,2005-07-23,2.1,
+2AGJ,2005-07-27,2.6,
+2AI0,2005-07-28,2.2,
+2AJ3,2005-08-01,2.03,
+2AJS,2005-08-02,1.7,
+2AJU,2005-08-02,1.5,
+2AJV,2005-08-02,1.5,
+2AJX,2005-08-02,1.85,
+2AJY,2005-08-02,2.1,
+2AJZ,2005-08-02,2.3,
+2AK1,2005-08-02,1.85,
+2AK4,2005-08-03,2.5,
+2AKR,2005-08-03,1.9,
+2AP2,1999-03-22,2.4,
+2APB,2005-08-16,1.8,
+2APF,2005-08-16,1.8,
+2APH,2005-08-16,2.1,
+2APT,2005-08-16,2.0,
+2APV,2005-08-16,1.9,
+2APW,2005-08-16,2.0,
+2APX,2005-08-16,1.8,
+2AQ1,2005-08-17,2.1,
+2AQ2,2005-08-17,1.8,
+2AQ3,2005-08-17,2.3,
+2ARJ,2005-08-19,2.88,
+2ATP,2005-08-25,2.4,
+2ATY,2005-08-26,,
+2AV1,2005-08-29,1.95,
+2AV7,2005-08-29,2.05,
+2AW2,2005-08-31,2.8,
+2AXH,2005-09-05,2.7,
+2AXJ,2005-09-05,2.65,
+2B0S,2005-09-14,2.3,
+2B1A,2005-09-15,2.348,
+2B1H,2005-09-15,2.0,
+2B2X,2005-09-19,2.2,
+2BC4,2005-10-18,2.27,
+2BCK,2005-10-19,2.8,
+2BDN,2005-10-20,2.53,
+2BJM,2005-02-04,2.15,
+2BL7,2005-03-02,2.2,
+2BMK,2005-03-14,2.3,
+2BO2,2005-04-07,2.6,
+2BOU,2005-04-14,1.9,
+2BOX,2005-04-14,2.5,
+2BRR,2005-05-11,1.95,
+2BVE,2005-06-27,2.2,
+2BX5,2005-07-22,2.7,
+2BZM,2005-08-18,,
+2C1O,2005-09-19,2.75,
+2C1P,2005-09-19,2.0,
+2CB3,2005-12-29,2.4,
+2CD0,1999-03-08,1.8,
+2CFE,2006-02-20,1.5,
+2CJU,2006-04-09,2.5,
+2CLV,2006-05-02,1.9,
+2CLZ,2006-05-03,1.9,
+2CMR,2006-05-11,2.0,
+2COQ,2005-05-18,2.1,
+2CPC,2005-05-19,,
+2CR2,2005-05-20,,
+2CRN,2005-05-20,,
+2CRY,2005-05-20,,
+2D03,2005-07-23,1.97,
+2D39,2005-09-26,1.9,
+2D3V,2005-10-03,1.85,
+2D4D,2005-10-17,2.1,
+2D4F,2005-10-18,1.7,
+2D7T,2005-11-29,1.7,
+2D9K,2005-12-10,,
+2DBG,2005-12-15,,
+2DDQ,2006-02-02,2.35,
+2DHK,2006-03-24,,
+2DHY,2006-03-27,,
+2DL2,1999-03-08,3.0,
+2DLF,1998-12-17,1.55,
+2DLI,1999-03-08,2.9,
+2DO4,2006-04-27,,
+2DQT,2006-05-30,1.8,
+2DQU,2006-05-30,1.7,
+2DRU,2006-06-15,2.6,
+2DTM,2006-07-13,2.25,
+2DTS,2006-07-14,2.2,
+2DYP,2006-09-15,2.5,
+2E27,2006-11-08,1.7,
+2E7L,2007-01-11,2.5,
+2EH7,2007-03-05,2.5,
+2EH8,2007-03-05,2.6,
+2EHF,2007-03-06,,
+2ESV,2005-10-27,2.6,
+2EYR,2005-11-09,2.4,
+2EYS,2005-11-09,2.21,
+2EYT,2005-11-09,2.6,
+2F08,2005-11-12,2.2,
+2F53,2005-11-25,2.1,
+2F54,2005-11-25,2.7,
+2F58,1998-10-23,2.8,
+2F74,2005-11-30,2.7,
+2F8O,2005-12-02,1.7,
+2FAT,2005-12-07,1.77,
+2FBO,2005-12-09,1.85,
+2FCB,1999-01-07,1.74,
+2FGW,1994-01-16,3.0,
+2FIK,2005-12-29,1.8,
+2FJF,2006-01-02,2.65,
+2FL5,2006-01-05,3.0,
+2FO4,2006-01-12,2.7,
+2FRG,2006-01-19,1.19,
+2FX7,2006-02-03,1.76,
+2FX8,2006-02-03,2.2,
+2FX9,2006-02-03,2.1,
+2FYY,2006-02-08,1.5,
+2FZ3,2006-02-09,1.9,
+2G2B,2006-02-15,,
+2G2R,2006-02-16,2.75,
+2G60,2006-02-23,1.85,
+2G75,2006-02-27,2.28,
+2G7I,2006-02-28,1.75,
+2G9H,2006-03-06,2.0,
+2GA0,2006-03-07,2.7,
+2GAZ,2006-03-09,2.61,
+2GCY,2006-03-14,2.5,
+2GIT,2006-03-29,1.7,
+2GJ6,2006-03-30,2.56,
+2GJJ,2006-03-31,2.1,
+2GJZ,2006-03-31,2.65,
+2GK0,2006-03-31,2.45,
+2GKI,2006-04-02,2.88,
+2GSG,2006-04-26,2.1,
+2GSI,2006-04-26,2.81,
+2GSX,2006-04-27,,
+2GT9,2006-04-27,1.75,
+2GTW,2006-04-28,1.548,
+2GTZ,2006-04-28,1.7,
+2GU9,2006-04-28,1.4,
+2GUO,2006-05-01,1.9,
+2GW5,2006-05-03,1.8,
+2H26,2006-05-18,1.8,
+2H2R,2006-05-19,1.5,
+2H2T,2006-05-19,1.3,
+2H32,2006-05-22,2.7,
+2H3N,2006-05-22,2.3,
+2H6P,2006-05-31,1.9,
+2HCI,2006-06-16,1.81,
+2HFF,2006-06-23,1.95,
+2HFG,2006-06-23,2.61,
+2HH0,2006-06-27,2.85,
+2HJK,2006-06-30,1.85,
+2HJL,2006-06-30,1.5,
+2HKF,2006-07-04,2.01,
+2HKH,2006-07-04,2.1,
+2HN7,2006-07-12,1.6,
+2HP4,2006-07-17,2.1,
+2HWZ,2006-08-02,1.8,
+2HYM,2006-08-07,,
+2I07,2006-08-10,4.0,
+2I24,2006-08-15,1.35,
+2I25,2006-08-15,1.8,
+2I26,2006-08-15,2.5,
+2I27,2006-08-15,1.92,
+2IAL,2006-09-08,1.92,
+2IAM,2006-09-08,2.8,
+2IAN,2006-09-08,2.8,
+2IC4,2006-09-12,,
+2ICC,2006-09-12,1.2,
+2ICE,2006-09-12,3.1,
+2ICF,2006-09-12,4.1,
+2ICW,2006-09-13,2.41,
+2IF7,2006-09-20,3.0,
+2IPK,2006-10-12,2.3,
+2IPT,2006-10-12,2.0,
+2IPU,2006-10-12,1.65,
+2IQ9,2006-10-13,2.3,
+2IQA,2006-10-13,2.0,
+2IT5,2006-10-19,2.4,
+2IT6,2006-10-19,1.95,
+2J4W,2006-09-07,2.5,
+2J5L,2006-09-18,2.9,
+2J6E,2006-09-28,3.0,
+2J8U,2006-10-27,2.88,
+2JA4,2006-11-21,2.21,
+2JB5,2006-12-03,2.8,
+2JB6,2006-12-03,2.85,
+2JCC,2006-12-21,2.5,
+2JG8,2007-02-09,2.05,
+2JG9,2007-02-09,1.9,
+2JJU,2008-04-22,1.19,
+2JJV,2008-04-22,1.8,
+2JKS,2008-08-29,1.9,
+2JOP,2007-03-19,,
+2JP0,2007-04-16,,
+2JRV,2007-06-29,,
+2JRW,2007-06-29,,
+2JSV,2007-07-16,,
+2JT9,2007-07-21,,
+2JVG,2007-09-20,,
+2JVH,2007-09-20,,
+2JWD,2007-10-09,,
+2JZP,2008-01-11,,
+2K3U,2008-05-16,,
+2KAC,2008-11-04,,
+2KDY,2009-01-20,,
+2KGY,2009-03-23,,
+2KJU,2009-06-10,,
+2KLK,2009-07-06,,
+2KMS,2009-08-04,,
+2KQ4,2009-10-27,,
+2KQM,2009-11-11,,
+2KQN,2009-11-11,,
+2KWD,2010-04-05,,
+2L9H,2011-02-09,,
+2LAG,2011-03-13,,
+2LKQ,2011-10-19,,
+2LMA,2011-11-29,,
+2LMS,2011-12-12,,
+2LNB,2011-12-20,,
+2LRA,2012-03-28,,
+2LS8,2012-04-23,,
+2LSQ,2012-05-04,,
+2M1W,2012-12-07,,
+2M1X,2012-12-07,,
+2M4F,2013-02-05,,
+2M5H,2013-02-25,,
+2M5V,2013-03-11,,
+2M63,2013-03-20,,
+2MAA,2013-07-02,,
+2MCP,1984-10-15,3.1,
+2MCR,2013-08-22,,
+2MCY,2013-08-27,,
+2MCZ,2013-08-27,,
+2MD0,2013-08-28,,
+2MIM,2013-12-15,,
+2MK3,2014-01-23,,
+2MK9,2014-02-04,,
+2MKA,2014-02-04,,
+2MKL,2014-02-10,,
+2MKW,2014-02-13,,
+2MMX,2014-03-20,,
+2MPA,1999-06-09,2.6,
+2MQG,2014-06-19,,
+2MTI,2014-08-19,,
+2MUA,2014-09-05,,
+2MUF,2014-09-09,,
+2MV8,2014-09-25,,
+2MV9,2014-09-25,,
+2N31,2015-05-19,,
+2N9K,2015-11-26,,
+2N9L,2015-11-30,,
+2NAN,2016-01-06,,
+2NDH,2016-05-27,,
+2NMS,2006-10-23,2.6,
+2NNA,2006-10-24,2.1,
+2NO8,2006-10-25,,
+2NOJ,2006-10-25,2.7,
+2NQC,2006-10-31,2.05,
+2NTF,2006-11-07,3.18,
+2NW2,2006-11-14,1.4,
+2NW3,2006-11-14,1.7,
+2NX5,2006-11-16,2.7,
+2O5X,2006-12-06,2.05,
+2O5Y,2006-12-06,2.85,
+2O5Z,2006-12-06,2.4,
+2O6Q,2006-12-08,2.5,
+2O6R,2006-12-08,2.3,
+2O6S,2006-12-08,1.5,
+2OCW,2006-12-21,,
+2OED,2006-12-29,,
+2OI9,2007-01-10,2.35,
+2OJE,2007-01-12,3.0,
+2OJZ,2007-01-15,2.73,
+2OL3,2007-01-18,2.9,
+2OLD,2007-01-19,2.6,
+2OMB,2007-01-21,2.9,
+2OMN,2007-01-22,2.2,
+2OP4,2007-01-26,2.85,
+2OQJ,2007-01-31,2.8,
+2OR7,2007-02-02,1.5,
+2OR8,2007-02-02,2.5,
+2OR9,2007-02-02,2.7,
+2ORB,2007-02-02,2.2,
+2OSL,2007-02-06,2.6,
+2OTP,2007-02-08,2.6,
+2OTT,2007-02-09,2.5,
+2OTU,2007-02-09,1.68,
+2OTW,2007-02-09,2.35,
+2P1Y,2007-03-06,2.42,
+2P24,2007-03-06,2.15,
+2P5E,2007-03-15,1.89,
+2P5W,2007-03-16,2.2,
+2PN5,2007-04-23,2.698,
+2PND,2007-04-24,1.0,
+2PTT,2007-05-08,1.63,
+2PTU,2007-05-08,2.38,
+2PTV,2007-05-08,1.66,
+2PW1,2007-05-10,2.6,
+2PW2,2007-05-10,2.55,
+2PXY,2007-05-14,2.23,
+2PYE,2007-05-16,2.3,
+2PYF,2007-05-16,2.2,
+2Q3A,2007-05-30,2.2,
+2Q6W,2007-06-05,2.25,
+2Q76,2007-06-06,2.0,
+2Q7Y,2007-06-07,1.95,
+2Q7Z,2007-06-08,,
+2Q86,2007-06-08,1.85,
+2Q87,2007-06-09,1.7,
+2Q8A,2007-06-10,2.4,
+2Q8B,2007-06-10,2.3,
+2QDN,2007-06-21,2.09,
+2QEJ,2007-06-26,3.2,
+2QFG,2007-06-27,,
+2QFH,2007-06-27,,
+2QHL,2007-07-02,1.56,
+2QJD,2007-07-06,2.44,
+2QL1,2007-07-12,2.534,
+2QMT,2007-07-16,1.05,
+2QOS,2007-07-20,1.81,
+2QQQ,2007-07-26,1.98,
+2QR0,2007-07-27,3.5,
+2QRI,2007-07-28,2.0,
+2QRS,2007-07-29,2.0,
+2QRT,2007-07-29,1.8,
+2QSC,2007-07-30,2.8,
+2QTE,2007-08-01,1.9,
+2QTJ,2007-08-02,,
+2QZD,2007-08-16,14.0,
+2QZF,2007-08-16,14.0,
+2QZH,2007-08-16,14.0,
+2R0W,2007-08-21,2.503,
+2R0Z,2007-08-21,2.096,
+2R1W,2007-08-23,1.7,
+2R1X,2007-08-23,1.6,
+2R1Y,2007-08-23,1.6,
+2R23,2007-08-24,1.65,
+2R2B,2007-08-24,1.6,
+2R2E,2007-08-24,2.4,
+2R2H,2007-08-25,2.0,
+2R2K,2007-08-26,3.25,
+2R32,2007-08-28,1.95,
+2R56,2007-09-03,2.8,
+2R90,2007-09-12,2.8,
+2R9U,2007-09-13,2.1,
+2RCJ,2007-09-20,,
+2RD7,2007-09-21,2.15,
+2RFX,2007-10-02,2.5,
+2RGS,2007-10-05,2.13,
+2RKQ,2007-10-17,1.5,
+2RLP,2007-07-28,,
+2RLQ,2007-07-29,,
+2RMM,2007-10-30,,
+2RPS,2008-07-28,,
+2RPV,2008-10-28,,
+2SPZ,1998-07-29,,
+2UUD,2007-03-02,2.9,
+2UWE,2007-03-20,2.4,
+2UWN,2007-03-22,2.35,
+2UX2,2007-03-26,1.8,
+2UYL,2007-04-10,2.5,
+2V17,2007-05-22,1.65,
+2V2W,2007-06-07,1.6,
+2V2X,2007-06-07,1.6,
+2V7H,2007-07-30,2.8,
+2V7N,2007-07-31,1.92,
+2V8E,2007-08-07,2.5,
+2VB5,2007-09-06,,
+2VE6,2007-10-17,2.65,
+2VH5,2007-11-19,2.7,
+2VL5,2008-01-08,2.1,
+2VLJ,2008-01-15,2.4,
+2VLK,2008-01-15,2.5,
+2VLL,2008-01-15,1.6,
+2VLM,2008-01-15,1.98,
+2VLR,2008-01-15,2.3,
+2VM6,2008-01-23,2.2,
+2VOK,2008-02-19,1.3,
+2VQ1,2008-03-10,2.5,
+2VUO,2008-05-27,1.95,
+2VWE,2008-06-23,3.4,
+2VXU,2008-07-10,2.36,
+2VXV,2008-07-10,1.49,
+2VXW,2008-07-12,1.7,
+2VYR,2008-07-28,2.0,
+2W0K,2008-08-19,2.35,
+2W0L,2008-08-19,2.2,
+2W59,2008-12-08,1.75,
+2W60,2008-12-16,1.5,
+2W65,2008-12-17,2.21,
+2W80,2009-01-08,2.35,
+2W81,2009-01-08,2.35,
+2W9D,2009-01-23,1.57,
+2W9E,2009-01-23,2.9,
+2WA0,2009-01-31,2.3,
+2WAH,2009-02-06,2.51,
+2WBJ,2009-03-02,3.0,
+2WCQ,2009-03-13,1.9,
+2WCR,2009-03-13,1.7,
+2WCY,2009-03-17,,
+2WII,2009-05-12,2.7,
+2WIN,2009-05-13,3.9,
+2WNP,2009-07-16,1.21,
+2WNU,2009-07-20,2.3,
+2WNV,2009-07-20,1.25,
+2WPT,2009-08-10,1.78,
+2WQR,2009-08-26,1.9,
+2WRY,2009-09-03,1.58,
+2WY7,2009-11-13,1.7,
+2WY8,2009-11-13,1.7,
+2X44,2010-01-28,2.6,
+2X4N,2010-02-02,2.34,
+2X4O,2010-02-02,2.3,
+2X4P,2010-02-02,2.3,
+2X4Q,2010-02-02,1.9,
+2X4R,2010-02-02,2.3,
+2X4S,2010-02-02,2.55,
+2X4T,2010-02-02,2.3,
+2X4U,2010-02-02,2.1,
+2X57,2010-02-05,2.1,
+2X5Y,2010-02-11,1.05,
+2X69,2010-02-15,2.65,
+2X6G,2010-02-17,2.18,
+2X6L,2010-02-17,2.602,
+2X6M,2010-02-18,1.62,
+2X70,2010-02-22,2.0,
+2X7A,2010-02-25,2.77,
+2X7L,2010-03-01,3.17,
+2X89,2010-03-07,2.16,
+2XA3,2010-03-29,1.5,
+2XA8,2010-03-30,2.42,
+2XCZ,2010-04-27,1.64,
+2XFX,2010-05-28,1.9,
+2XKN,2010-07-09,1.4,
+2XKS,2010-07-12,,
+2XKU,2010-07-12,,
+2XL4,2010-07-19,2.3,
+2XN9,2010-07-31,2.3,
+2XNA,2010-07-31,2.1,
+2XPG,2010-08-26,2.6,
+2XQB,2010-09-01,2.6,
+2XQW,2010-09-07,2.306,
+2XRA,2010-09-13,2.3,
+2XRB,2010-09-13,2.5,
+2XRC,2010-09-13,2.69,
+2XRD,2010-09-14,3.5,
+2XTM,2010-10-11,1.7,
+2XTN,2010-10-11,1.9,
+2XTO,2010-10-11,2.8,
+2XTP,2010-10-11,1.5,
+2XXC,2010-11-10,1.67,
+2XZ4,2010-11-23,1.72,
+2XZ8,2010-11-24,1.94,
+2XZA,2010-11-24,1.5,
+2XZC,2010-11-24,1.36,
+2XZQ,2010-12-01,2.4,
+2Y06,2010-11-30,2.5,
+2Y07,2010-11-30,2.4,
+2Y36,2010-12-18,2.7,
+2Y5T,2011-01-17,2.2,
+2Y7Q,2011-02-01,3.4,
+2Y7S,2011-02-01,1.9,
+2Y92,2011-02-11,3.01,
+2YBY,2011-03-30,1.58,
+2YEZ,2011-03-31,2.9,
+2YF2,2011-04-01,2.24,
+2YHF,2011-04-30,1.9,
+2YK1,2011-05-25,1.85,
+2YKL,2011-05-27,2.1,
+2YMX,2012-10-10,1.9,
+2YPA,2012-10-30,2.8,
+2YPB,2012-10-30,2.87,
+2YPK,2012-10-30,1.95,
+2YPV,2012-11-01,1.8,
+2YRP,2007-04-02,,
+2YUZ,2007-04-06,,
+2YWY,2007-04-23,2.71,
+2YWZ,2007-04-23,2.21,
+2YXF,2007-04-26,1.13,
+2YZ1,2007-05-02,1.4,
+2Z31,2007-05-30,2.7,
+2Z35,2007-06-01,2.2,
+2Z4Q,2007-06-22,2.3,
+2Z5V,2007-07-19,,
+2Z62,2007-07-22,1.7,
+2Z63,2007-07-22,2.0,
+2Z64,2007-07-22,2.84,
+2Z65,2007-07-22,2.7,
+2Z66,2007-07-22,1.9,
+2Z7X,2007-08-29,2.1,
+2Z80,2007-08-30,1.8,
+2Z81,2007-08-30,1.8,
+2Z82,2007-08-30,2.6,
+2Z8V,2007-09-11,2.35,
+2Z8W,2007-09-11,2.45,
+2Z91,2007-09-14,2.6,
+2Z92,2007-09-14,2.3,
+2Z93,2007-09-14,2.4,
+2Z9N,2007-09-21,3.2,
+2Z9T,2007-09-26,1.8,
+2ZCH,2007-11-08,2.83,
+2ZCK,2007-11-09,3.1,
+2ZCL,2007-11-09,3.25,
+2ZKH,2008-03-21,2.04,
+2ZOK,2008-05-22,2.1,
+2ZOL,2008-05-22,2.7,
+2ZPK,2008-07-16,1.8,
+2ZSV,2008-09-18,1.8,
+2ZSW,2008-09-18,2.8,
+2ZW0,2008-11-26,1.4,
+2ZW1,2008-11-26,1.6,
+32C2,1999-04-21,3.0,
+3A79,2009-09-20,2.9,
+3A7B,2009-09-20,2.53,
+3A7C,2009-09-20,2.4,
+3AAZ,2009-11-28,2.2,
+3AB0,2009-11-28,3.09,
+3AM8,2010-08-18,2.8,
+3ARB,2010-11-26,2.7,
+3ARD,2010-11-27,3.01,
+3ARE,2010-11-27,2.8,
+3ARF,2010-11-27,2.9,
+3ARG,2010-11-27,3.0,
+3AU1,2011-01-28,2.5,
+3AUV,2011-02-16,2.4,
+3AVE,2011-03-04,2.0,
+3AXL,2011-04-11,2.9,
+3AY4,2011-04-28,2.2,
+3B2D,2011-07-29,2.8,
+3B3I,2007-10-22,1.86,
+3B5G,2007-10-25,1.9,
+3B6S,2007-10-29,1.8,
+3B9K,2007-11-05,2.7,
+3B9V,2007-11-06,1.8,
+3BAE,2007-11-07,1.593,
+3BD3,2007-11-14,1.6,
+3BD4,2007-11-14,2.4,
+3BD5,2007-11-14,2.0,
+3BDB,2007-11-14,2.8,
+3BDX,2007-11-15,2.3,
+3BES,2007-11-20,2.2,
+3BEV,2007-11-20,2.1,
+3BEW,2007-11-20,2.6,
+3BGM,2007-11-27,1.6,
+3BH8,2007-11-28,1.65,
+3BH9,2007-11-28,1.7,
+3BHB,2007-11-28,2.2,
+3BI9,2007-11-30,2.95,
+3BIA,2007-11-30,2.2,
+3BIB,2007-11-30,2.5,
+3BIK,2007-11-30,2.65,
+3BIS,2007-11-30,2.64,
+3BJ9,2007-12-03,2.0,
+3BKC,2007-12-06,1.9,
+3BKJ,2007-12-06,1.59,
+3BKM,2007-12-07,1.6,
+3BKY,2007-12-07,2.61,
+3BO8,2007-12-17,1.8,
+3BOV,2007-12-17,1.77,
+3BP4,2007-12-18,1.85,
+3BP7,2007-12-18,1.8,
+3BPC,2007-12-18,1.85,
+3BQU,2007-12-20,3.0,
+3BT1,2007-12-27,2.8,
+3BT2,2007-12-27,2.5,
+3BUY,2008-01-03,2.6,
+3BVN,2008-01-07,2.55,
+3BW9,2008-01-08,1.75,
+3BWA,2008-01-08,1.3,
+3BXN,2008-01-14,1.864,
+3BZ4,2008-01-17,1.8,
+3BZE,2008-01-17,2.5,
+3BZF,2008-01-17,2.5,
+3C08,2008-01-18,2.15,
+3C2A,2008-01-24,2.1,
+3C2S,2008-01-25,2.3,
+3C2X,2008-01-26,1.83,
+3C5S,2008-02-01,2.0,
+3C6S,2008-02-05,1.8,
+3C8J,2008-02-12,2.6,
+3C8K,2008-02-12,2.9,
+3C9N,2008-02-18,1.87,
+3CC5,2008-02-24,1.91,
+3CCH,2008-02-25,2.6,
+3CCK,2008-02-26,1.8,
+3CDC,2008-02-26,1.53,
+3CDF,2008-02-26,1.53,
+3CDG,2008-02-26,3.4,
+3CDY,2008-02-27,2.43,
+3CFB,2008-03-03,1.6,
+3CFC,2008-03-03,1.7,
+3CFD,2008-03-03,2.5,
+3CFE,2008-03-03,2.99,
+3CFJ,2008-03-04,2.6,
+3CFK,2008-03-04,2.6,
+3CG9,2008-03-05,2.9,
+3CH1,2008-03-06,2.3,
+3CHN,2008-03-10,,
+3CIG,2008-03-11,2.66,
+3CII,2008-03-11,4.41,
+3CIQ,2008-03-11,2.9,
+3CK0,1999-06-14,3.0,
+3CLE,2008-03-18,2.5,
+3CLF,2008-03-18,2.0,
+3CM9,2008-03-21,,
+3CMO,2008-03-24,2.3,
+3COR,2008-03-29,3.1,
+3CPL,2008-03-31,2.5,
+3CU7,2008-04-16,3.105,
+3CUP,2008-04-16,3.09,
+3CVH,2008-04-18,2.9,
+3CVI,2008-04-18,1.8,
+3CXD,2008-04-24,2.8,
+3CZF,2008-04-29,1.2,
+3D0L,2008-05-01,2.35,
+3D0V,2008-05-02,2.05,
+3D18,2008-05-05,1.74,
+3D25,2008-05-07,1.3,
+3D2U,2008-05-08,2.21,
+3D34,2008-05-09,1.8,
+3D39,2008-05-09,2.81,
+3D3V,2008-05-12,2.8,
+3D5O,2008-05-16,2.8,
+3D69,2008-05-19,3.77,
+3D6G,2008-05-19,2.3,
+3DBX,2008-06-02,2.0,
+3DGG,2008-06-13,2.3,
+3DHJ,2008-06-18,2.0,
+3DHM,2008-06-18,1.8,
+3DIF,2008-06-20,2.4,
+3DJ9,2008-06-22,1.75,
+3DMM,2008-07-01,2.6,
+3DNK,2008-07-02,2.84,
+3DO3,2008-07-03,2.5,
+3DRO,2008-07-11,3.9,
+3DRQ,2008-07-11,2.0,
+3DRT,2008-07-11,3.3,
+3DSF,2008-07-12,2.8,
+3DTX,2008-07-16,2.1,
+3DUR,2008-07-17,1.86,
+3DUS,2008-07-17,1.95,
+3DUU,2008-07-17,1.95,
+3DV4,2008-07-18,1.95,
+3DV6,2008-07-18,1.95,
+3DVG,2008-07-18,2.6,
+3DVN,2008-07-18,2.7,
+3DWT,2008-07-23,2.9,
+3DX6,2008-07-23,1.701,
+3DX7,2008-07-23,1.6,
+3DX8,2008-07-23,2.1,
+3DX9,2008-07-24,2.75,
+3DXA,2008-07-23,3.5,
+3E2H,2008-08-05,3.8,
+3E3Q,2008-08-07,2.95,
+3E6F,2008-08-15,2.41,
+3E6H,2008-08-15,2.1,
+3E6J,2008-08-15,1.67,
+3E8U,2008-08-20,2.1,
+3EAK,2008-08-26,1.95,
+3ECB,2008-08-29,1.698,
+3EFD,2008-09-08,2.6,
+3EGS,2008-09-11,3.6,
+3EIP,1999-03-29,1.8,
+3EKC,2008-09-19,1.8,
+3EO0,2008-09-26,1.75,
+3EO9,2008-09-26,1.8,
+3EOT,2008-09-29,1.9,
+3EP1,2008-09-29,2.1,
+3ERY,2008-10-03,1.95,
+3ESU,2008-10-06,1.3,
+3ESV,2008-10-06,2.0,
+3ET9,2008-10-07,2.8,
+3EYF,2008-10-20,2.3,
+3EYO,2008-10-21,2.5,
+3EYQ,2008-10-21,2.4,
+3EYS,2008-10-21,1.95,
+3EYU,2008-10-21,2.71,
+3EYV,2008-10-22,2.5,
+3EZM,1998-12-15,1.5,
+3F12,2008-10-27,2.95,
+3F4M,2008-11-01,1.696,
+3F58,1998-10-23,2.8,
+3FCT,1999-06-13,2.4,
+3FEW,2008-12-01,2.45,
+3FF9,2008-12-02,1.8,
+3FFC,2008-12-03,2.8,
+3FJT,2008-12-15,2.5,
+3FMG,2008-12-22,3.4,
+3FN0,2008-12-22,1.8,
+3FN3,2008-12-23,2.7,
+3FO0,2008-12-27,2.5,
+3FO1,2008-12-27,2.2,
+3FO2,2008-12-27,2.18,
+3FO9,2008-12-29,1.9,
+3FOL,2008-12-30,2.5,
+3FOM,2008-12-30,2.1,
+3FON,2008-12-30,2.03,
+3FPR,2009-01-06,1.63,
+3FPT,2009-01-06,2.7,
+3FPU,2009-01-06,1.76,
+3FQN,2009-01-07,1.65,
+3FQR,2009-01-07,1.7,
+3FQT,2009-01-07,1.8,
+3FQU,2009-01-07,1.8,
+3FQW,2009-01-07,1.927,
+3FQX,2009-01-07,1.7,
+3FT2,2009-01-12,1.8,
+3FT3,2009-01-12,1.95,
+3FT4,2009-01-12,1.9,
+3FTG,2009-01-12,2.6,
+3FXI,2009-01-21,3.1,
+3FZU,2009-01-26,2.5,
+3G04,2009-01-27,2.55,
+3G08,2009-01-27,1.6,
+3G39,2009-02-02,1.55,
+3G5V,2009-02-05,2.001,
+3G5X,2009-02-05,2.3,
+3G5Y,2009-02-05,1.59,
+3G5Z,2009-02-05,2.6,
+3G6A,2009-02-06,2.1,
+3G6D,2009-02-06,3.2,
+3G6J,2009-02-06,3.1,
+3G7X,2009-02-11,1.55,
+3G8K,2009-02-12,2.0,
+3G8L,2009-02-12,2.5,
+3GAQ,2009-02-18,2.25,
+3GAU,2009-02-18,,
+3GAV,2009-02-18,,
+3GAW,2009-02-18,,
+3GBL,2009-02-20,2.1,
+3GGW,2009-03-02,1.7,
+3GHB,2009-03-03,2.25,
+3GHE,2009-03-03,2.4,
+3GIV,2009-03-06,2.0,
+3GIZ,2009-03-07,2.2,
+3GJE,2009-03-08,2.3,
+3GJF,2009-03-08,1.9,
+3GJZ,2009-03-09,2.1,
+3GK8,2009-03-10,2.0,
+3GKZ,2009-03-11,1.9,
+3GM0,2009-03-12,2.4,
+3GML,2009-03-14,1.7,
+3GMM,2009-03-14,1.8,
+3GMN,2009-03-14,1.7,
+3GMO,2009-03-14,1.6,
+3GMP,2009-03-14,1.7,
+3GMQ,2009-03-14,1.8,
+3GMR,2009-03-14,1.9,
+3GNM,2009-03-17,2.1,
+3GO1,2009-03-18,1.89,
+3GOD,2009-03-18,2.17,
+3GSN,2009-03-27,2.8,
+3GSO,2009-03-27,1.6,
+3GSQ,2009-03-27,2.12,
+3GSR,2009-03-27,1.95,
+3GSU,2009-03-27,1.8,
+3GSV,2009-03-27,1.9,
+3GSW,2009-03-27,1.81,
+3GSX,2009-03-27,2.1,
+3H3B,2009-04-16,2.45,
+3H3P,2009-04-16,2.7,
+3H7B,2009-04-24,1.88,
+3H8N,2009-04-29,2.5,
+3H9H,2009-04-30,2.0,
+3H9S,2009-04-30,2.7,
+3H9Y,2009-04-30,2.23,
+3H9Z,2009-04-30,2.45,
+3HA0,2009-04-30,2.8,
+3HAE,2009-05-01,2.9,
+3HC0,2009-05-05,1.9,
+3HC3,2009-05-05,1.72,
+3HC4,2009-05-05,1.62,
+3HCV,2009-05-06,1.95,
+3HE6,2009-05-07,2.9,
+3HE7,2009-05-08,2.8,
+3HG1,2009-05-13,3.0,
+3HI5,2009-05-18,2.5,
+3HKF,2009-05-23,2.5,
+3HMW,2009-05-29,3.0,
+3HNS,2009-06-01,2.0,
+3HNT,2009-06-01,1.8,
+3HNV,2009-06-01,2.0,
+3HPJ,2009-06-04,2.0,
+3HQA,2009-06-05,2.586,
+3HQB,2009-06-05,3.299,
+3HR5,2009-06-08,2.4,
+3HRZ,2009-06-10,2.2,
+3HS0,2009-06-10,3.0,
+3HUJ,2009-06-14,2.5,
+3HUP,2009-06-15,1.371,
+3HZK,2009-06-23,2.15,
+3HZM,2009-06-23,1.8,
+3HZV,2009-06-24,1.9,
+3HZY,2009-06-24,2.1,
+3I02,2009-06-24,2.6,
+3I2C,2009-06-29,2.8,
+3I6G,2009-07-07,2.201,
+3I6K,2009-07-07,2.8,
+3I6L,2009-07-07,2.4,
+3I75,2009-07-08,1.95,
+3I9G,2009-07-10,1.9,
+3IB4,2009-07-15,1.25,
+3IDG,2009-07-21,1.86,
+3IDI,2009-07-21,2.1,
+3IDJ,2009-07-21,2.24,
+3IDM,2009-07-21,2.24,
+3IDN,2009-07-21,2.25,
+3IDX,2009-07-22,2.5,
+3IDY,2009-07-22,3.2,
+3IE4,2009-07-22,1.45,
+3IET,2009-07-23,2.2,
+3IF1,2009-07-23,2.39,
+3IFL,2009-07-24,1.5,
+3IFN,2009-07-24,1.5,
+3IFO,2009-07-24,2.15,
+3IFP,2009-07-24,2.95,
+3IJH,2009-08-04,2.1,
+3IJS,2009-08-04,2.55,
+3IJY,2009-08-05,2.85,
+3IKC,2009-08-05,2.6,
+3ILP,2009-08-07,1.85,
+3ILQ,2009-08-07,2.05,
+3INO,2009-08-12,1.95,
+3INU,2009-08-12,2.5,
+3IT8,2009-08-27,2.8,
+3IU3,2009-08-29,2.9,
+3IU4,2009-08-29,1.75,
+3IXA,2009-09-03,2.1,
+3IXT,2009-09-04,2.75,
+3IY0,2009-04-07,12.5,
+3IY1,2009-04-09,18.0,
+3IY2,2009-04-09,18.0,
+3IY3,2009-04-09,11.1,
+3IY4,2009-04-09,11.7,
+3IY5,2009-04-09,18.0,
+3IY6,2009-04-09,12.0,
+3IY7,2009-04-09,14.0,
+3J0A,2011-06-02,26.0,
+3J24,2012-08-17,9.0,
+3J2X,2013-01-28,15.6,
+3J2Y,2013-01-28,14.9,
+3J2Z,2013-01-28,16.9,
+3J30,2013-01-28,16.0,
+3J3Z,2013-05-21,23.4,
+3J6J,2014-03-13,3.64,
+3J7E,2014-06-23,13.6,
+3J93,2014-12-02,8.8,
+3JBL,2015-09-05,4.7,
+3JTS,2009-09-14,2.801,
+3JTT,2009-09-14,2.8,
+3JUY,2009-09-15,2.5,
+3JVG,2009-09-16,2.2,
+3K2D,2009-09-30,2.6,
+3K3Q,2009-10-04,2.6,
+3K51,2009-10-06,2.45,
+3KAA,2009-10-19,3.002,
+3KCW,2009-10-22,2.0,
+3KDM,2009-10-23,1.5,
+3KGR,2009-10-29,1.8,
+3KJ4,2009-11-02,3.1,
+3KLA,2009-11-07,1.65,
+3KLS,2009-11-09,3.6,
+3KM9,2009-11-10,4.2,
+3KPH,2009-11-16,2.8,
+3KPL,2009-11-16,1.96,
+3KPM,2009-11-16,1.6,
+3KPN,2009-11-16,2.0,
+3KPO,2009-11-16,2.3,
+3KPP,2009-11-16,1.9,
+3KPR,2009-11-16,2.6,
+3KPS,2009-11-16,2.7,
+3KQG,2009-11-17,2.3,
+3KR3,2009-11-17,2.2,
+3KWW,2009-12-01,2.18,
+3KXF,2009-12-03,3.1,
+3KXV,2009-12-04,2.004,
+3KYK,2009-12-06,3.2,
+3KYM,2009-12-06,2.62,
+3KYN,2009-12-06,2.4,
+3KYO,2009-12-06,1.7,
+3KZJ,2009-12-08,1.65,
+3L1O,2009-12-14,2.0,
+3L3D,2009-12-16,1.8,
+3L3G,2009-12-16,2.1,
+3L3H,2009-12-17,2.7,
+3L3I,2009-12-17,1.7,
+3L3J,2009-12-17,2.4,
+3L3K,2009-12-17,2.6,
+3L3O,2009-12-17,3.405,
+3L5H,2009-12-21,3.6,
+3L5I,2009-12-22,1.9,
+3L5J,2009-12-22,3.042,
+3L5N,2009-12-22,7.536,
+3L5W,2009-12-22,2.0,
+3L5X,2009-12-22,1.9,
+3L7E,2009-12-28,2.5,
+3L7F,2009-12-28,2.6,
+3L95,2010-01-04,2.19,
+3L9J,2010-01-05,2.1,
+3LD8,2010-01-12,2.7,
+3LDB,2010-01-12,2.7,
+3LEF,2010-01-14,2.3,
+3LES,2010-01-15,2.77,
+3LEV,2010-01-15,2.5,
+3LEX,2010-01-15,1.97,
+3LEY,2010-01-15,1.99,
+3LF6,2010-01-15,1.9,
+3LF9,2010-01-16,2.0,
+3LG7,2010-01-19,2.5,
+3LH2,2010-01-21,2.65,
+3LHP,2010-01-22,2.7,
+3LKN,2010-01-27,2.0,
+3LKO,2010-01-27,1.8,
+3LKP,2010-01-27,1.8,
+3LKQ,2010-01-27,1.8,
+3LKR,2010-01-27,2.0,
+3LKS,2010-01-27,1.9,
+3LMJ,2010-01-30,2.2,
+3LN4,2010-02-01,1.296,
+3LN5,2010-02-02,1.9,
+3LN9,2010-02-02,1.8,
+3LQA,2010-02-08,3.4,
+3LQZ,2010-02-10,3.25,
+3LRG,2010-02-11,2.05,
+3LRH,2010-02-11,2.6,
+3LRS,2010-02-11,2.37,
+3LS4,2010-02-12,2.0,
+3LS5,2010-02-12,1.9,
+3LV3,2010-02-19,1.94,
+3LXX,2010-02-25,2.15,
+3M18,2010-03-04,1.95,
+3M19,2010-03-04,1.7,
+3M7O,2010-03-17,1.65,
+3M8O,2010-03-18,1.55,
+3MA7,2010-03-23,2.29,
+3MA9,2010-03-23,2.05,
+3MAC,2010-03-23,2.5,
+3MBE,2010-03-25,2.886,
+3MBX,2010-03-26,1.6,
+3MC0,2010-03-26,2.0,
+3MCK,2010-03-29,2.3,
+3MCL,2010-03-29,1.7,
+3MFF,2010-04-02,2.0,
+3MGO,2010-04-07,2.297,
+3MGT,2010-04-07,2.197,
+3MHD,2010-04-07,2.901,
+3MI8,2010-04-09,2.951,
+3MJ6,2010-04-12,2.19,
+3MJ7,2010-04-12,2.8,
+3MJ8,2010-04-12,2.94,
+3MJ9,2010-04-12,2.95,
+3MLR,2010-04-18,1.8,
+3MLS,2010-04-18,2.5,
+3MLT,2010-04-18,2.49,
+3MLU,2010-04-18,2.77,
+3MLV,2010-04-18,2.48,
+3MLW,2010-04-18,2.7,
+3MLX,2010-04-18,1.9,
+3MLY,2010-04-18,1.7,
+3MLZ,2010-04-18,2.99,
+3MME,2010-04-19,3.97,
+3MNV,2010-04-22,2.4,
+3MNW,2010-04-22,2.2,
+3MNZ,2010-04-22,1.8,
+3MO1,2010-04-22,1.8,
+3MOA,2010-04-22,2.3,
+3MOB,2010-04-22,2.6,
+3MOD,2010-04-22,2.2,
+3MR9,2010-04-29,1.93,
+3MRB,2010-04-29,1.4,
+3MRC,2010-04-29,1.8,
+3MRD,2010-04-29,1.7,
+3MRE,2010-04-29,1.1,
+3MRF,2010-04-29,2.3,
+3MRG,2010-04-29,1.3,
+3MRH,2010-04-29,2.4,
+3MRI,2010-04-29,2.1,
+3MRJ,2010-04-29,1.87,
+3MRK,2010-04-29,1.4,
+3MRL,2010-04-29,2.41,
+3MRM,2010-04-29,1.9,
+3MRN,2010-04-29,2.3,
+3MRO,2010-04-29,2.35,
+3MRP,2010-04-29,2.1,
+3MRQ,2010-04-29,2.2,
+3MRR,2010-04-29,1.6,
+3MTX,2010-05-01,2.0,
+3MU3,2010-05-01,2.4,
+3MUG,2010-05-03,2.49,
+3MUH,2010-05-03,3.0,
+3MV7,2010-05-03,2.0,
+3MV8,2010-05-03,2.1,
+3MV9,2010-05-03,2.7,
+3MXV,2010-05-07,1.9,
+3MYJ,2010-05-10,1.89,
+3MYZ,2010-05-11,1.6,
+3MZT,2010-05-13,2.7,
+3N9G,2010-05-29,1.434,
+3NA4,2010-06-01,1.9,
+3NA9,2010-06-01,1.7,
+3NAA,2010-06-01,1.7,
+3NAB,2010-06-01,2.32,
+3NAC,2010-06-01,1.8,
+3NCJ,2010-06-04,1.6,
+3NFN,2010-06-10,2.392,
+3NFS,2010-06-10,2.6,
+3NG4,2010-06-10,1.73,
+3NH7,2010-06-14,2.7,
+3NI0,2010-06-14,1.601,
+3NKD,2010-06-18,1.95,
+3NKE,2010-06-18,1.4,
+3NMS,2010-06-22,4.1,
+3NN8,2010-06-23,3.1,
+3NOI,2010-06-25,1.842,
+3NSJ,2010-07-01,2.75,
+3NSW,2010-07-02,1.75,
+3NT8,2010-07-02,2.2,
+3NTC,2010-07-03,1.55,
+3NW3,2010-07-09,2.5,
+3NWM,2010-07-09,2.7,
+3NZ8,2010-07-16,2.7,
+3NZH,2010-07-16,2.0,
+3O11,2010-07-20,2.8,
+3O2D,2010-07-22,2.19,
+3O2V,2010-07-22,2.3,
+3O2W,2010-07-22,2.55,
+3O3A,2010-07-23,1.8,
+3O3B,2010-07-23,1.9,
+3O3D,2010-07-23,1.7,
+3O3E,2010-07-23,1.85,
+3O4K,2010-07-27,2.11,
+3O4L,2010-07-27,2.54,
+3O4O,2010-07-27,3.3,
+3O6F,2010-07-29,2.8,
+3O6K,2010-07-29,2.0,
+3O6L,2010-07-29,2.1,
+3O6M,2010-07-29,2.4,
+3O81,2010-08-02,2.0,
+3O8X,2010-08-03,2.74,
+3O9W,2010-08-04,2.8,
+3OAU,2010-08-05,1.9,
+3OAY,2010-08-05,1.95,
+3OAZ,2010-08-06,1.75,
+3OB0,2010-08-06,2.85,
+3OED,2010-08-12,3.16,
+3OF6,2010-08-13,2.8,
+3OGX,2010-08-17,2.8,
+3OHX,2010-08-18,3.503,
+3OJD,2010-08-22,2.0,
+3OJY,2010-08-23,2.51,
+3OKD,2010-08-24,1.8,
+3OKE,2010-08-24,2.4,
+3OKK,2010-08-25,1.95,
+3OKL,2010-08-25,1.8,
+3OKM,2010-08-25,2.4,
+3OKN,2010-08-25,2.15,
+3OKO,2010-08-25,2.45,
+3OMZ,2010-08-27,3.04,
+3OQ2,2010-09-02,1.35,
+3OSK,2010-09-09,1.8,
+3OV6,2010-09-15,2.502,
+3OWE,2010-09-17,2.6,
+3OX8,2010-09-21,2.16,
+3OXR,2010-09-21,1.7,
+3OXS,2010-09-22,1.75,
+3OXU,2010-09-22,2.1,
+3OZ9,2010-09-24,1.6,
+3P0V,2010-09-29,2.85,
+3P0Y,2010-09-29,1.8,
+3P11,2010-09-29,3.7,
+3P2T,2010-10-04,1.699,
+3P30,2010-10-04,3.3,
+3P4M,2010-10-06,2.5,
+3P4N,2010-10-06,2.5,
+3P4O,2010-10-06,2.3,
+3P73,2010-10-12,1.32,
+3P77,2010-10-12,1.6,
+3P7F,2010-10-12,2.5,
+3P7G,2010-10-12,1.5,
+3P7H,2010-10-12,2.3,
+3P9L,2010-10-18,2.0,
+3P9M,2010-10-18,2.0,
+3PAB,2010-10-19,2.2,
+3PDO,2010-10-23,1.95,
+3PGC,2010-11-01,2.66,
+3PGD,2010-11-01,2.72,
+3PIQ,2010-11-07,3.325,
+3PL6,2010-11-13,2.55,
+3PP3,2010-11-24,2.508,
+3PP4,2010-11-24,1.6,
+3PQY,2010-11-28,3.192,
+3PV6,2010-12-06,2.3,
+3PV7,2010-12-06,2.0,
+3PVM,2010-12-07,4.3,
+3PVN,2010-12-07,1.98,
+3PVO,2010-12-07,3.0,
+3PWU,2010-12-09,1.899,
+3PWV,2010-12-09,2.696,
+3Q0H,2010-12-15,1.7,
+3Q2C,2010-12-20,2.5,
+3Q5T,2010-12-29,2.005,
+3Q5Y,2010-12-30,1.9,
+3Q6F,2010-12-31,3.192,
+3Q6G,2010-12-31,1.902,
+3QCT,2011-01-17,2.1493,
+3QCU,2011-01-17,1.979,
+3QCV,2011-01-17,2.51,
+3QDA,2011-01-18,1.57,
+3QDG,2011-01-18,2.69,
+3QDJ,2011-01-18,2.3,
+3QDM,2011-01-18,2.8,
+3QEG,2011-01-20,1.95,
+3QEH,2011-01-20,2.59,
+3QEQ,2011-01-20,2.59,
+3QEU,2011-01-20,2.09,
+3QFD,2011-01-21,1.68,
+3QFJ,2011-01-21,2.29,
+3QG7,2011-01-24,2.78,
+3QH3,2011-01-25,2.19,
+3QHF,2011-01-25,1.655,
+3QHZ,2011-01-26,1.55,
+3QI9,2011-01-26,2.3,
+3QIB,2011-01-26,2.7,
+3QIU,2011-01-27,2.7,
+3QIW,2011-01-27,3.3,
+3QJ1,2011-01-28,3.2,
+3QJF,2011-01-28,2.4,
+3QJH,2011-01-28,1.9,
+3QKG,2011-02-01,2.3,
+3QNX,2011-02-09,2.2,
+3QNY,2011-02-09,2.3,
+3QNZ,2011-02-09,2.2,
+3QO0,2011-02-09,2.3,
+3QO1,2011-02-09,2.4,
+3QPQ,2011-02-14,1.9,
+3QPX,2011-02-14,2.0,
+3QQ3,2011-02-15,2.59,
+3QQ4,2011-02-15,2.097,
+3QQ9,2011-02-15,1.64,
+3QRG,2011-02-17,1.699,
+3QS0,2011-02-19,2.5,
+3QUK,2011-02-24,2.41,
+3QUL,2011-02-24,2.0,
+3QUM,2011-02-24,3.2,
+3QUX,2011-02-24,2.91,
+3QUY,2011-02-24,2.25,
+3QUZ,2011-02-24,2.3,
+3QV4,2011-02-25,2.7,
+3QWO,2011-02-28,1.9,
+3QXA,2011-03-01,2.712,
+3QXD,2011-03-01,2.302,
+3QXT,2011-03-02,1.7,
+3QXU,2011-03-02,1.8,
+3QXV,2011-03-02,2.5,
+3QXW,2011-03-02,1.85,
+3QYC,2011-03-03,1.6,
+3QZW,2011-03-07,2.798,
+3R06,2011-03-07,2.5,
+3R08,2011-03-07,4.1,
+3R0M,2011-03-08,1.5,
+3R62,2011-03-21,1.52,
+3RA7,2011-03-27,2.798,
+3RBG,2011-03-29,2.3,
+3RDT,2011-04-01,2.7,
+3REV,2011-04-05,2.2,
+3REW,2011-04-05,1.9,
+3RG1,2011-04-07,2.91,
+3RGV,2011-04-09,2.9,
+3RJD,2011-04-15,2.65,
+3RL1,2011-04-19,2.0,
+3RL2,2011-04-19,2.386,
+3RNK,2011-04-22,1.74,
+3RNQ,2011-04-22,1.6,
+3ROL,2011-04-26,2.6,
+3ROO,2011-04-26,2.0,
+3RP1,2011-04-26,2.6,
+3RPI,2011-04-26,2.648,
+3RQ3,2011-04-27,2.7,
+3RRQ,2011-04-29,2.1,
+3RS1,2011-05-02,1.94,
+3RT4,2011-05-03,1.7,
+3RTQ,2011-05-03,2.8,
+3RUG,2011-05-05,2.2,
+3RVT,2011-05-06,2.05,
+3RVU,2011-05-06,2.5,
+3RWC,2011-05-09,2.502,
+3RWD,2011-05-09,2.602,
+3RWE,2011-05-09,2.4,
+3RWF,2011-05-09,2.6,
+3RWG,2011-05-09,2.1,
+3RWH,2011-05-09,2.6,
+3RWI,2011-05-09,2.009,
+3RWJ,2011-05-09,2.7,
+3RY4,2011-05-11,1.5,
+3RY5,2011-05-11,2.3,
+3RY6,2011-05-11,3.8,
+3RZC,2011-05-11,2.8,
+3S34,2011-05-17,2.2,
+3S4S,2011-05-20,2.4,
+3S5L,2011-05-23,2.1,
+3S62,2011-05-24,4.01,
+3S7G,2011-05-26,3.13,
+3S96,2011-05-31,1.9,
+3SBW,2011-06-06,2.28,
+3SCM,2011-06-08,2.5,
+3SDA,2011-06-08,2.8,
+3SDC,2011-06-09,3.1,
+3SDD,2011-06-09,3.0,
+3SDX,2011-06-09,3.12,
+3SGD,2011-06-14,2.31,
+3SGE,2011-06-14,1.89,
+3SGJ,2011-06-15,2.2,
+3SGK,2011-06-15,2.4,
+3SJV,2011-06-22,3.1,
+3SKJ,2011-06-22,2.5,
+3SKM,2011-06-22,1.8,
+3SKN,2011-06-22,2.9,
+3SKO,2011-06-22,1.6,
+3SPV,2011-07-04,1.3,
+3SW0,2011-07-13,1.8,
+3SY0,2011-07-15,1.489,
+3T0E,2011-07-20,4.0,
+3T1F,2011-07-21,1.7,
+3T2V,2011-07-23,2.51,
+3T39,2011-07-25,2.7,
+3T46,2011-07-25,1.5,
+3T47,2011-07-25,1.301,
+3T48,2011-07-25,1.5,
+3T49,2011-07-25,1.45,
+3T4A,2011-07-25,3.4,
+3T4Y,2011-07-26,1.73,
+3T5M,2011-07-27,1.749,
+3T5O,2011-07-27,2.869,
+3T5S,2011-07-28,2.3,
+3T65,2011-07-28,1.45,
+3T6Q,2011-07-28,1.9,
+3T77,2011-07-29,1.739,
+3T8X,2011-08-02,1.9,
+3TA3,2011-08-03,2.7,
+3TCL,2011-08-09,1.906,
+3TF7,2011-08-15,2.75,
+3TFK,2011-08-15,2.753,
+3THM,2011-08-19,2.1,
+3TID,2011-08-20,1.65,
+3TIE,2011-08-20,2.25,
+3TJE,2011-08-24,1.93,
+3TJH,2011-08-24,2.12,
+3TLR,2011-08-30,2.45,
+3TM6,2011-08-31,2.7,
+3TN0,2011-09-01,3.2,
+3TNM,2011-09-01,1.85,
+3TNN,2011-09-01,1.95,
+3TO2,2011-09-03,2.6,
+3TO4,2011-09-04,3.1,
+3TPK,2011-09-08,1.3,
+3TPU,2011-09-08,3.1,
+3TRU,2011-09-10,3.2,
+3TV3,2011-09-19,1.29,
+3TVM,2011-09-20,2.8,
+3TWC,2011-09-21,1.65,
+3TWI,2011-09-21,2.55,
+3TYF,2011-09-24,2.806,
+3TYX,2011-09-26,2.04,
+3TZV,2011-09-27,3.056,
+3U0P,2011-09-28,2.8,
+3U0T,2011-09-29,2.5,
+3U0W,2011-09-29,2.0,
+3U1B,2011-09-29,1.604,
+3U1S,2011-09-30,2.3,
+3U2S,2011-10-04,1.797,
+3U30,2011-10-04,2.428,
+3U36,2011-10-04,3.281,
+3U46,2011-10-07,2.906,
+3U4B,2011-10-07,2.893,
+3U4E,2011-10-07,2.185,
+3U6R,2011-10-12,2.67,
+3U79,2011-10-13,1.62,
+3U7A,2011-10-13,2.0,
+3U7W,2011-10-14,2.6,
+3U9P,2011-10-19,2.8,
+3UB2,2011-10-23,2.4,
+3UB3,2011-10-23,2.75,
+3UB4,2011-10-23,3.1,
+3UBX,2011-10-25,3.1,
+3UIL,2011-11-05,2.2,
+3UJI,2011-11-07,1.6,
+3UJJ,2011-11-07,2.0,
+3UJT,2011-11-08,2.1,
+3UL7,2011-11-10,2.37,
+3UL8,2011-11-10,2.5,
+3UL9,2011-11-10,2.45,
+3ULA,2011-11-10,3.6,
+3ULS,2011-11-11,2.495,
+3ULU,2011-11-11,3.52,
+3ULV,2011-11-11,3.522,
+3UMQ,2011-11-14,2.2,
+3UMT,2011-11-14,1.798,
+3UN9,2011-11-15,2.65,
+3UO1,2011-11-16,1.641,
+3UP1,2011-11-17,2.15,
+3UPA,2011-11-17,1.8,
+3UPC,2011-11-17,2.8,
+3UPR,2011-11-18,1.999,
+3UR1,2011-11-21,4.5,
+3USX,2011-11-24,2.28,
+3UTP,2011-11-26,2.574,
+3UTQ,2011-11-26,1.67,
+3UTS,2011-11-26,2.712,
+3UTT,2011-11-26,2.6,
+3UTZ,2011-11-27,2.18,
+3UX2,2011-12-03,1.8,
+3UX3,2011-12-03,1.8,
+3UYP,2011-12-06,2.0,
+3UYR,2011-12-06,1.7,
+3UZE,2011-12-07,2.04,
+3UZQ,2011-12-07,1.6,
+3UZV,2011-12-07,2.1,
+3V0V,2011-12-08,2.13,
+3V0W,2011-12-08,1.73,
+3V3X,2011-12-14,2.0,
+3V44,2011-12-14,2.83,
+3V47,2011-12-14,2.47,
+3V4U,2011-12-15,1.64,
+3V52,2011-12-15,1.697,
+3V56,2011-12-16,3.0,
+3V5D,2011-12-16,2.0,
+3V5H,2011-12-16,1.63,
+3V5K,2011-12-16,2.31,
+3V6F,2011-12-19,2.52,
+3V6O,2011-12-20,1.95,
+3V6Z,2011-12-20,3.34,
+3V70,2011-12-20,2.206,
+3V7A,2011-12-20,3.297,
+3V7M,2011-12-21,2.02,
+3V8C,2011-12-22,2.77,
+3V95,2011-12-23,2.7,
+3VBC,2012-01-02,1.8,
+3VCL,2012-01-04,1.7,
+3VFG,2012-01-09,1.65,
+3VFM,2012-01-10,1.9,
+3VFN,2012-01-10,1.5,
+3VFO,2012-01-10,1.7,
+3VFP,2012-01-10,1.85,
+3VFR,2012-01-10,1.85,
+3VFS,2012-01-10,1.85,
+3VFT,2012-01-10,1.947,
+3VFU,2012-01-10,1.65,
+3VFV,2012-01-10,1.55,
+3VFW,2012-01-10,2.3,
+3VG0,2012-01-10,2.27,
+3VH8,2011-08-24,1.8,
+3VJ6,2011-10-12,1.9,
+3VPP,2012-03-07,1.642,
+3VQ1,2012-03-17,2.7,
+3VQ2,2012-03-17,2.48,
+3VRI,2012-04-11,1.6,
+3VRJ,2012-04-11,1.9,
+3VWJ,2012-08-24,3.093,
+3VWK,2012-08-24,2.935,
+3VXM,2012-09-20,2.5,
+3VXN,2012-09-20,1.95,
+3VXO,2012-09-20,2.61,
+3VXP,2012-09-20,2.5,
+3VXQ,2012-09-20,2.0,
+3VXR,2012-09-20,2.4,
+3VXS,2012-09-20,1.8,
+3VXT,2012-09-20,2.5,
+3VXU,2012-09-20,2.7,
+3W0W,2012-11-05,2.603,
+3W2D,2012-11-28,3.1,
+3W2V,2012-12-06,2.6,
+3W2W,2012-12-06,2.5,
+3W30,2012-12-07,2.99,
+3W31,2012-12-07,2.96,
+3W39,2012-12-13,3.1,
+3W3G,2012-12-21,2.3,
+3W3J,2012-12-22,2.0,
+3W3K,2012-12-22,2.3,
+3W3L,2012-12-22,2.33,
+3W3M,2012-12-22,2.7,
+3W3N,2012-12-22,2.1,
+3W9D,2013-04-03,2.32,
+3WBD,2013-05-14,1.8,
+3WD5,2013-06-06,3.101,
+3WE6,2013-07-01,2.02,
+3WEX,2013-07-16,2.4,
+3WFH,2013-07-19,1.9,
+3WH2,2013-08-21,1.3,
+3WH3,2013-08-21,1.32,
+3WHD,2013-08-24,2.29,
+3WHX,2013-09-03,1.7,
+3WIF,2013-09-12,1.7,
+3WIH,2013-09-12,1.701,
+3WII,2013-09-12,1.6,
+3WJJ,2013-10-10,2.6,
+3WJL,2013-10-11,2.86,
+3WKN,2013-10-29,2.9,
+3WL9,2013-11-08,1.66,
+3WLB,2013-11-08,2.0,
+3WN4,2013-12-02,1.81,
+3WN5,2013-12-05,2.78,
+3WO2,2013-12-19,2.33,
+3WO3,2013-12-19,3.1,
+3WO4,2013-12-19,3.1,
+3WO9,2013-12-20,2.3,
+3WS3,2014-02-28,2.335,
+3WS6,2014-02-28,1.98,
+3WTF,2014-04-09,3.451,
+3WYR,2014-09-07,2.8,
+3X11,2014-10-24,2.15,
+3X12,2014-10-24,1.8,
+3X13,2014-10-24,1.8,
+3X14,2014-10-25,2.0,
+3X3G,2015-01-20,2.51,
+3ZC4,2012-11-15,2.72,
+3ZD1,2012-11-23,2.0,
+3ZD2,2012-11-23,1.99,
+3ZGQ,2012-12-19,2.203,
+3ZHD,2012-12-21,1.962,
+3ZHG,2012-12-21,1.87,
+3ZHK,2012-12-22,1.962,
+3ZHL,2012-12-22,2.47,
+3ZL4,2013-01-28,1.95,
+3ZUI,2011-07-19,1.71,
+3ZUO,2011-07-19,1.86,
+3ZWZ,2011-08-03,2.1,
+3ZZO,2011-09-02,1.15,
+3ZZR,2011-09-02,1.45,
+4A5W,2011-10-28,3.5,
+4A6Y,2011-11-10,2.9,
+4ACJ,2011-12-15,0.97,
+4ACP,2011-12-16,2.49,
+4ACV,2011-12-19,2.401,
+4AEH,2012-01-10,1.6,
+4AEN,2012-01-11,2.2,
+4AEQ,2012-01-12,1.892,
+4AH2,2012-02-03,2.36,
+4AIX,2012-02-15,1.8,
+4AIZ,2012-02-15,1.75,
+4AJ0,2012-02-15,1.7,
+4AKA,2012-02-22,,
+4AL8,2012-03-02,1.66,
+4ALA,2012-03-02,1.84,
+4AMK,2012-03-12,2.05,
+4AN8,2012-03-16,2.3,
+4APQ,2012-04-05,3.0,
+4ARN,2012-04-25,2.41,
+4ARR,2012-04-26,3.0,
+4AT6,2012-05-04,2.549,
+4AT9,2012-05-05,2.803,
+4ATB,2012-05-05,3.1,
+4AYD,2012-06-20,2.4,
+4AYE,2012-06-20,2.8,
+4AYI,2012-06-21,2.31,
+4AYM,2012-06-21,3.0,
+4AYN,2012-06-21,2.06,
+4B0F,2012-07-02,2.8,
+4B2R,2012-07-17,,
+4B2S,2012-07-17,,
+4B41,2012-07-27,1.191,
+4B50,2012-08-02,1.3,
+4B53,2012-08-02,1.8,
+4B5E,2012-08-03,1.936,
+4B7I,2012-08-20,2.36,
+4BA8,2012-09-12,,
+4BFE,2013-03-18,2.5,
+4BFG,2013-03-18,2.08,
+4BFI,2013-03-19,3.22,
+4BH7,2013-03-30,2.89,
+4BH8,2013-03-30,2.4,
+4BIG,2013-04-10,2.274,
+4BIH,2013-04-10,2.459,
+4BIK,2013-04-10,3.494,
+4BKL,2013-04-26,3.25,
+4BLI,2013-05-03,1.08,
+4BM7,2013-05-07,1.95,
+4BSV,2013-06-11,1.75,
+4BSW,2013-06-11,2.15,
+4BTZ,2013-06-19,1.47,
+4BUH,2013-06-20,1.3,
+4BV4,2013-06-24,2.35,
+4BYH,2013-07-19,2.3,
+4C0M,2013-08-05,2.8,
+4C54,2013-09-10,1.9,
+4C55,2013-09-10,2.35,
+4C6R,2013-09-19,2.05,
+4C6S,2013-09-19,1.751,
+4C6T,2013-09-19,2.65,
+4C83,2013-09-29,2.69,
+4CAJ,2013-10-08,2.191,
+4CDH,2013-10-31,2.3,
+4CNI,2014-01-22,2.2,
+4CP3,2014-01-31,2.3,
+4CVX,2014-03-31,3.3,
+4CVZ,2014-03-31,2.39,
+4CW1,2014-03-31,2.58,
+4D0B,2014-04-25,2.8,
+4D0C,2014-04-25,2.81,
+4D0D,2014-04-25,3.13,
+4D2N,2014-05-12,2.7,
+4D8P,2012-01-11,3.05,
+4D94,2012-01-11,2.7,
+4D9L,2012-01-11,2.485,
+4DB5,2012-01-13,1.522,
+4DCQ,2012-01-18,1.94,
+4DDD,2012-01-18,1.9,
+4DEP,2012-01-21,3.1,
+4DMB,2012-02-07,1.9,
+4DN3,2012-02-08,2.6,
+4DN4,2012-02-08,2.8,
+4DQO,2012-02-16,2.438,
+4DVB,2012-02-23,1.93,
+4DZ8,2012-02-29,1.91,
+4DZB,2012-03-01,1.7,
+4E0R,2012-03-05,2.26,
+4E0S,2012-03-05,4.21,
+4E41,2012-03-11,2.6,
+4E42,2012-03-11,2.7,
+4E4S,2012-03-13,1.95,
+4EBQ,2012-03-23,1.6,
+4EDW,2012-03-27,2.48,
+4EDX,2012-03-27,2.5,
+4EF4,2012-03-29,2.147,
+4EF5,2012-03-29,2.45,
+4EI5,2012-04-04,3.1,
+4EI6,2012-04-04,1.6,
+4ELK,2012-04-10,2.1,
+4ELM,2012-04-11,3.48,
+4EN3,2012-04-12,2.568,
+4EOW,2012-04-16,1.97,
+4EQ2,2012-04-18,2.502,
+4EQ3,2012-04-18,2.001,
+4ERS,2012-04-20,2.637,
+4ES7,2012-04-22,2.001,
+4ESK,2012-04-23,1.762,
+4ETY,2012-04-24,1.9,
+4EUP,2012-04-25,2.88,
+4EVN,2012-04-26,2.851,
+4EZM,2012-05-03,3.1,
+4F15,2012-05-06,2.81,
+4F33,2012-05-08,1.749,
+4F37,2012-05-09,2.57,
+4F3E,2012-05-09,2.4,
+4F3F,2012-05-09,2.65,
+4F57,2012-05-12,1.7,
+4F58,2012-05-12,2.488,
+4F5D,2012-05-13,3.0,
+4F5E,2012-05-13,2.601,
+4F5W,2012-05-13,2.201,
+4F5Y,2012-05-13,2.396,
+4F7C,2012-05-15,2.864,
+4F7E,2012-05-15,2.4,
+4F7M,2012-05-16,2.4,
+4F7P,2012-05-16,1.9,
+4F7T,2012-05-16,1.7,
+4F80,2012-05-16,1.944,
+4F8Q,2012-05-17,2.3789,
+4F8T,2012-05-17,2.382,
+4F9L,2012-05-18,3.1404,
+4F9P,2012-05-19,3.519,
+4FH0,2012-06-05,1.4,
+4FHQ,2012-06-06,2.251,
+4FNL,2012-06-19,2.297,
+4FNN,2012-06-20,2.24,
+4FQ1,2012-06-24,3.0,
+4FQ2,2012-06-24,1.9,
+4FQC,2012-06-25,2.4,
+4FQH,2012-06-25,2.05,
+4FQL,2012-06-25,1.898,
+4FQQ,2012-06-25,2.42,
+4FQX,2012-06-25,2.599,
+4FTV,2012-06-28,2.74,
+4FXL,2012-07-03,1.4,
+4FZ4,2012-07-06,2.44,
+4FZ5,2012-07-06,3.6,
+4FZ8,2012-07-06,2.66,
+4FZE,2012-07-06,1.999,
+4FZQ,2012-07-07,2.5,
+4G2U,2012-07-13,1.85,
+4G3Y,2012-07-15,2.6,
+4G42,2012-07-16,2.294,
+4G43,2012-07-16,1.803,
+4G4F,2012-07-16,1.847,
+4G59,2012-07-17,2.44,
+4G5Z,2012-07-18,1.83,
+4G6A,2012-07-18,2.501,
+4G6F,2012-07-19,2.1,
+4G6J,2012-07-19,2.03,
+4G6K,2012-07-19,1.9,
+4G6M,2012-07-19,1.81,
+4G8A,2012-07-23,2.4,
+4G8E,2012-07-23,2.2,
+4G8F,2012-07-23,2.1,
+4G8G,2012-07-23,2.4,
+4G8I,2012-07-23,1.6,
+4G96,2012-07-23,2.25,
+4G9A,2012-07-23,2.001,
+4G9D,2012-07-23,1.6,
+4G9F,2012-07-23,1.9,
+4GAG,2012-07-25,1.8,
+4GAJ,2012-07-25,2.51,
+4GAY,2012-07-26,2.65,
+4GBX,2012-07-28,3.0,
+4GG6,2012-08-06,3.2,
+4GG8,2012-08-06,3.2,
+4GHU,2012-08-08,2.199,
+4GI0,2012-08-08,2.27,
+4GJ0,2012-08-09,1.953,
+4GJH,2012-08-09,2.805,
+4GJX,2012-08-10,2.8,
+4GK1,2012-08-10,2.236,
+4GKN,2012-08-13,2.753,
+4GKO,2012-08-13,3.3,
+4GKS,2012-08-13,2.346,
+4GKZ,2012-08-13,2.39,
+4GLP,2012-08-14,4.002,
+4GLR,2012-08-14,1.9,
+4GMT,2012-08-16,2.05,
+4GOS,2012-08-20,1.59,
+4GQP,2012-08-23,2.0,
+4GRL,2012-08-25,2.86,
+4GRM,2012-08-25,2.0,
+4GRW,2012-08-27,2.55,
+4GS7,2012-08-27,2.35,
+4GSD,2012-08-27,2.251,
+4GT7,2012-08-28,2.61,
+4GUP,2012-08-29,3.2,
+4GW1,2012-08-31,2.24,
+4GW4,2012-08-31,2.65,
+4GW5,2012-08-31,2.2,
+4GXV,2012-09-04,1.449,
+4H0G,2012-09-08,2.3,
+4H0H,2012-09-08,2.0,
+4H0I,2012-09-08,2.4,
+4H1L,2012-09-10,3.3,
+4H20,2012-09-11,1.9,
+4H25,2012-09-12,2.2,
+4H26,2012-09-12,2.5,
+4H6H,2012-09-19,2.5024,
+4H6I,2012-09-19,3.091,
+4H88,2012-09-21,1.9,
+4HAF,2012-09-26,2.04,
+4HAG,2012-09-26,3.4,
+4HBC,2012-09-27,1.54,
+4HBQ,2012-09-28,1.4,
+4HC1,2012-09-28,2.871,
+4HCR,2012-10-01,2.3,
+4HD9,2012-10-02,1.7,
+4HDI,2012-10-02,2.449,
+4HFW,2012-10-05,2.601,
+4HGK,2012-10-08,3.04,
+4HGM,2012-10-08,2.34,
+4HGW,2012-10-08,1.65,
+4HH9,2012-10-09,1.7,
+4HHA,2012-10-09,1.6,
+4HIE,2012-10-11,1.9,
+4HIH,2012-10-11,2.0,
+4HII,2012-10-11,2.3,
+4HIJ,2012-10-11,2.1,
+4HJ0,2012-10-12,3.0,
+4HJG,2012-10-12,2.0,
+4HJJ,2012-10-12,2.1,
+4HK0,2012-10-14,2.497,
+4HK3,2012-10-14,3.0,
+4HKB,2012-10-15,3.6,
+4HKZ,2012-10-15,2.08,
+4HQQ,2012-10-25,2.4,
+4HR9,2012-10-26,2.48,
+4HS3,2012-10-29,2.1,
+4HS6,2012-10-29,1.53,
+4HS8,2012-10-29,2.6,
+4HT1,2012-10-31,2.498,
+4HUU,2012-11-04,2.0,
+4HUV,2012-11-04,2.5,
+4HUW,2012-11-04,3.16,
+4HUX,2012-11-05,2.2,
+4HV8,2012-11-05,2.0,
+4HW5,2012-11-07,2.25,
+4HWB,2012-11-07,2.61,
+4HWE,2012-11-07,2.43,
+4HWJ,2012-11-08,2.6,
+4HWN,2012-11-08,2.006,
+4HWU,2012-11-08,2.903,
+4HWZ,2012-11-09,2.397,
+4HX1,2012-11-09,1.802,
+4HXA,2012-11-09,2.06,
+4HXB,2012-11-09,2.45,
+4HZL,2012-11-15,2.85,
+4I0K,2012-11-16,2.97,
+4I0P,2012-11-18,3.2,
+4I2X,2012-11-23,2.48,
+4I48,2012-11-27,2.799,
+4I4W,2012-11-28,1.77,
+4I5B,2012-11-28,2.12,
+4I6O,2012-11-29,2.14,
+4IA5,2012-12-06,2.22,
+4IA6,2012-12-06,1.8,
+4IDJ,2012-12-12,3.36,
+4IDL,2012-12-12,2.09,
+4IFP,2012-12-14,1.9948,
+4IHO,2012-12-19,2.8,
+4IIQ,2012-12-20,2.86,
+4IMK,2013-01-03,2.202,
+4IML,2013-01-03,2.931,
+4IOI,2013-01-07,1.95,
+4IOP,2013-01-08,3.2,
+4IRJ,2013-01-14,3.0,
+4IRS,2013-01-15,2.8,
+4IRZ,2013-01-15,2.84,
+4IS6,2013-01-16,2.5,
+4ISV,2013-01-17,1.497,
+4IXD,2013-01-25,1.8,
+4J12,2013-01-31,1.9,
+4J1U,2013-02-02,2.58,
+4J38,2013-02-05,2.83,
+4J4P,2013-02-07,2.91,
+4J6G,2013-02-11,2.4,
+4J6J,2013-02-11,1.9,
+4J6K,2013-02-11,2.3,
+4J6L,2013-02-11,3.15,
+4J6M,2013-02-11,2.48,
+4J6N,2013-02-11,2.85,
+4J6P,2013-02-11,1.9,
+4J6Q,2013-02-11,2.539,
+4J8R,2013-02-14,2.303,
+4JAM,2013-02-18,1.65,
+4JC5,2013-02-21,2.75,
+4JDV,2013-02-25,1.65,
+4JFD,2013-02-28,2.46,
+4JFE,2013-02-28,2.7,
+4JFF,2013-02-28,2.43,
+4JFH,2013-02-28,2.4,
+4JFO,2013-02-28,2.11,
+4JFP,2013-02-28,1.91,
+4JFQ,2013-02-28,1.9,
+4JFX,2013-02-28,1.95,
+4JFY,2013-02-28,2.63,
+4JFZ,2013-02-28,1.75,
+4JG0,2013-02-28,1.81,
+4JG1,2013-02-28,1.55,
+4JGJ,2013-03-01,2.6508,
+4JHA,2013-03-04,1.6,
+4JHW,2013-03-05,3.6,
+4JJ5,2013-03-07,2.445,
+4JKW,2013-03-12,2.01,
+4JLR,2013-03-12,2.71,
+4JM4,2013-03-13,1.751,
+4JN1,2013-03-14,1.89,
+4JO4,2013-03-16,2.27,
+4JPB,2013-03-19,3.186,
+4JPI,2013-03-19,2.1,
+4JQV,2013-03-20,1.5,
+4JQX,2013-03-20,1.9,
+4JRX,2013-03-22,2.3,
+4JRY,2013-03-22,2.8,
+4JVO,2013-03-25,1.3,
+4JVP,2013-03-26,1.76,
+4JY4,2013-03-29,2.8,
+4JY5,2013-03-29,1.75,
+4JY6,2013-03-29,2.5,
+4K07,2013-04-03,2.83,
+4K23,2013-04-08,1.6,
+4K24,2013-04-08,4.5,
+4K2U,2013-04-09,2.45,
+4K3D,2013-04-10,1.85,
+4K3E,2013-04-10,2.2,
+4K3G,2013-04-10,1.93,
+4K5U,2013-04-15,1.698,
+4K79,2013-04-16,2.2,
+4K7F,2013-04-17,2.0,
+4K7P,2013-04-17,2.95,
+4K8R,2013-04-18,3.22,
+4K94,2013-04-19,2.4,
+4K9E,2013-04-19,2.7,
+4KAQ,2013-04-22,2.48,
+4KBY,2013-04-24,2.36,
+4KC0,2013-04-24,2.2,
+4KC3,2013-04-24,3.2702,
+4KDT,2013-04-25,2.6,
+4KGH,2013-04-29,2.806,
+4KGO,2013-04-29,3.194,
+4KGQ,2013-04-29,2.27,
+4KH3,2013-04-30,2.5,
+4KHT,2013-05-01,2.817,
+4KHX,2013-05-01,2.921,
+4KI1,2013-05-01,3.2,
+4KI5,2013-05-01,2.47,
+4KJY,2013-05-04,1.93,
+4KK0,2013-05-05,2.9,
+4KK1,2013-05-05,3.3,
+4KKN,2013-05-06,2.253,
+4KMT,2013-05-08,2.1,
+4KPH,2013-05-13,2.59,
+4KQ3,2013-05-14,1.92,
+4KQ4,2013-05-14,2.45,
+4KRN,2013-05-16,1.553,
+4KSY,2013-05-18,1.881,
+4KTD,2013-05-20,2.0,
+4KTE,2013-05-20,1.8,
+4KU1,2013-05-21,1.9,
+4KUZ,2013-05-22,2.7,
+4KV5,2013-05-22,3.0,
+4KVC,2013-05-22,2.306,
+4KVN,2013-05-22,3.1,
+4KXF,2013-05-25,3.2,
+4KXZ,2013-05-28,2.83,
+4KY1,2013-05-28,2.97,
+4L1H,2013-06-03,1.68,
+4L29,2013-06-04,3.09,
+4L3C,2013-06-05,2.64,
+4L3E,2013-06-05,2.557,
+4L4J,2013-06-07,1.92,
+4L5T,2013-06-11,3.405,
+4L8B,2013-06-16,2.2,
+4L8C,2013-06-16,2.8,
+4L8D,2013-06-16,1.9,
+4L8I,2013-06-17,2.0,
+4L8S,2013-06-17,2.9,
+4L9L,2013-06-18,3.4,
+4LAQ,2013-06-20,2.8,
+4LAR,2013-06-20,2.38,
+4LAS,2013-06-20,2.33,
+4LCC,2013-06-21,3.263,
+4LCI,2013-06-21,1.9,
+4LEX,2013-06-26,2.02,
+4LF3,2013-06-26,2.735,
+4LFH,2013-06-26,2.3,
+4LHU,2013-07-01,2.87,
+4LIQ,2013-07-03,2.6,
+4LKC,2013-07-07,2.2,
+4LKX,2013-07-09,1.92,
+4LL9,2013-07-09,2.686,
+4LLA,2013-07-09,2.502,
+4LLD,2013-07-09,1.19,
+4LLM,2013-07-09,1.75,
+4LLQ,2013-07-09,1.42,
+4LLU,2013-07-09,2.16,
+4LLV,2013-07-09,2.39,
+4LLW,2013-07-09,1.95,
+4LLY,2013-07-09,1.6,
+4LNR,2013-07-12,2.0,
+4LNV,2013-07-12,3.7,
+4LOH,2013-07-12,2.25,
+4LOI,2013-07-12,1.89,
+4LOJ,2013-07-12,1.77,
+4LOK,2013-07-12,2.07,
+4LOL,2013-07-12,2.43,
+4LQC,2013-07-17,2.3,
+8ZBY,2024-04-28,3.67,
+8ZBZ,2024-04-28,4.71,
+8ZC0,2024-04-28,4.17,
+8ZC1,2024-04-28,4.17,
+8ZC2,2024-04-28,7.82,
+8ZC3,2024-04-28,4.69,
+8ZC4,2024-04-28,3.95,
+8ZC5,2024-04-28,3.91,
+8ZC6,2024-04-28,6.85,
+8ZCJ,2024-04-29,3.09,
+8ZDW,2024-05-03,3.45,
+8ZER,2024-05-06,3.1,
+8ZES,2024-05-06,3.7,
+8ZGU,2024-05-09,3.51,
+8ZH8,2024-05-10,3.19,
+8ZHD,2024-05-10,3.41,
+8ZHE,2024-05-10,3.16,
+8ZHF,2024-05-10,5.26,
+8ZHG,2024-05-10,3.51,
+8ZHH,2024-05-10,5.55,
+8ZHI,2024-05-11,6.05,
+8ZHJ,2024-05-11,8.45,
+8ZHK,2024-05-11,6.3,
+8ZHL,2024-05-11,3.96,
+8ZHM,2024-05-11,3.39,
+8ZHN,2024-05-11,4.12,
+8ZHO,2024-05-11,3.54,
+8ZHP,2024-05-11,3.66,
+8ZL9,2024-05-17,4.36,
+8ZOY,2024-05-29,2.5,
+8ZP1,2024-05-29,2.5,
+8ZP2,2024-05-29,2.4,
+8ZP9,2024-05-29,2.8,
+8ZPB,2024-05-29,2.6,
+8ZR4,2024-06-03,1.9,
+8ZRH,2024-06-04,3.6,
+8ZRR,2024-06-05,3.61,
+8ZSJ,2024-06-05,2.8,
+8ZSP,2024-06-05,3.14,
+8ZSS,2024-06-05,3.07,
+8ZSV,2024-06-05,2.96,
+9ASD,2024-02-25,3.3,
+9ATO,2024-02-27,3.2,
+9ATP,2024-02-27,3.5,
+9AU2,2024-02-28,3.1,
+9AXL,2024-03-06,3.3,
+9B2C,2024-03-14,3.0,
+9B2M,2024-03-15,3.09,
+9B2W,2024-03-17,2.51,
+9B3K,2024-03-19,2.56,
+9B82,2024-03-28,3.38,
+9B9Y,2024-04-03,3.5,
+9B9Z,2024-04-03,3.3,
+9BA0,2024-04-03,3.13,
+9BER,2024-04-16,4.1,
+9BEW,2024-04-16,3.3,
+9BF6,2024-04-16,4.5,
+9BIO,2024-04-23,2.83,
+9BLX,2024-05-02,1.96,
+9BP1,2024-05-06,3.58,
+9BQJ,2024-05-10,3.3,
+9BU6,2024-05-16,3.65,
+9BU8,2024-05-16,3.96,
+9C45,2024-06-03,3.2,
+9CBN,2024-06-19,3.33,
+9CJ7,2024-07-05,3.0,
+9CJ8,2024-07-05,3.74,
+9CK7,2024-07-08,3.45,
+9CK8,2024-07-08,3.04,
+9CO7,2024-07-16,3.32,
+9CO8,2024-07-16,2.99,
+9CO9,2024-07-16,3.44,
+9CQ4,2024-07-19,3.27,
+9CQ7,2024-07-19,3.21,
+9CQ8,2024-07-19,3.45,
+9CZ7,2024-08-04,2.57,
+9CZA,2024-08-05,2.49,
+9CZD,2024-08-05,2.23,
+9CZF,2024-08-05,2.53,
+9DWE,2024-10-09,2.8,
+9DZQ,2024-10-16,3.57,
+9E6K,2024-10-30,3.15,
+9IJD,2024-06-22,2.76,
+9IJE,2024-06-22,2.34,
+9IMA,2024-07-02,2.65,
+9IQT,2024-07-13,2.9,
+9IVK,2024-07-23,2.74,
+9J7Y,2024-08-20,2.59,
+9JBQ,2024-08-27,2.0,
+9JR2,2024-09-29,2.8,
+9JR3,2024-09-29,2.8,
+1GC1,1998-06-15,2.5,
+1GHQ,2001-01-11,2.04,
+1JV5,2001-08-28,2.2,
+1KWT,2002-01-30,1.95,
+1KWU,2002-01-30,1.95,
+1KWV,2002-01-30,2.0,
+1KWW,2002-01-30,1.9,
+1KWX,2002-01-30,2.0,
+1KWY,2002-01-30,2.0,
+1KWZ,2002-01-30,1.9,
+1KX0,2002-01-30,2.0,
+1KX1,2002-01-30,2.8,
+1KZA,2002-02-06,1.74,
+1KZB,2002-02-06,1.8,
+1KZC,2002-02-06,1.85,
+1KZD,2002-02-06,1.9,
+1KZE,2002-02-06,1.8,
+1NQ3,2003-01-21,2.2,
+1OSY,2003-03-20,1.7,
+1PYW,2003-07-09,2.1,
+1URL,2003-10-31,2.4,
+1XPH,2004-10-08,1.41,
+1YVH,2005-02-15,2.05,
+2AF5,2005-07-25,2.5,
+2F2L,2005-11-17,2.1,
+2FJG,2006-01-02,2.8,
+2FJH,2006-01-02,3.1,
+2GJ7,2006-03-30,5.0,
+2PO6,2007-04-25,3.2,
+2ZG1,2008-01-17,2.7,
+2ZG2,2008-01-17,2.85,
+2ZG3,2008-01-17,3.0,
+2ZX0,2008-12-19,1.9,
+2ZX1,2008-12-19,1.9,
+2ZX2,2008-12-19,1.8,
+2ZX3,2008-12-19,2.1,
+2ZX4,2008-12-19,2.7,
+3C22,2008-01-24,1.5,
+3C5Z,2008-02-01,2.55,
+3C60,2008-02-01,3.05,
+3C6L,2008-02-04,3.4,
+3K7U,2009-10-13,2.1,
+3K80,2009-10-13,2.4,
+3K81,2009-10-13,3.4,
+3L6F,2009-12-23,2.1,
+3RU8,2011-05-04,2.07,
+3S6C,2011-05-25,2.9,
+3STB,2011-07-09,2.5,
+3W11,2012-11-06,3.9,
+3W12,2012-11-06,4.301,
+3W13,2012-11-06,4.303,
+3ZDY,2012-12-03,2.45,
+3ZDZ,2012-12-03,2.75,
+3ZE0,2012-12-03,2.95,
+3ZE1,2012-12-03,3.0,
+3ZE2,2012-12-03,2.35,
+4BZ2,2013-07-23,2.03,
+4DK3,2012-02-03,2.76,
+4DK6,2012-02-03,2.65,
+4DKA,2012-02-03,1.97,
+4DTG,2012-02-21,1.8,
+4K12,2013-04-04,1.079,
+4K3J,2013-04-10,2.8,
+4OGA,2014-01-15,3.5,
+4R4F,2014-08-19,3.514,
+4R4H,2014-08-19,4.28,
+4R4N,2014-08-19,3.56,
+4RFO,2014-09-26,3.2,
+4S10,2015-01-07,2.614,
+4S1R,2015-01-14,3.214,
+4S1S,2015-01-14,3.39,
+4UTA,2014-07-18,3.0,
+5GS2,2016-08-13,3.592,
+5H5Z,2016-11-10,1.74,
+5H7C,2016-11-17,2.7,
+5KJR,2016-06-20,2.98,
+5KQV,2016-07-06,4.4,
+5UK4,2017-01-19,3.204,
+5UKB,2017-01-20,5.473,
+5W3O,2017-06-08,3.01,
+6C5H,2018-01-16,1.99,
+6C5J,2018-01-16,2.29,
+6Q1Z,2019-08-06,3.446,
+6Q20,2019-08-06,2.45,
+6Q23,2019-08-06,3.27,
+6U2F,2019-08-19,2.94,
+6U3I,2019-08-21,2.9,
+6VEP,2020-01-02,2.9,
+6WPW,2020-04-28,3.1,
+7JTR,2020-08-18,2.5,
+7M72,2021-03-26,2.4,
+7MTA,2021-05-13,4.1,
+7MTB,2021-05-13,4.0,
+7MX4,2021-05-18,1.73,
+7MXF,2021-05-19,2.0,
+7MXH,2021-05-19,2.11,
+7TQB,2022-01-26,3.1,
+7YIT,2022-07-18,3.3,
+8CX0,2022-05-19,2.7,
+8CX1,2022-05-19,3.3,
+8CX2,2022-05-19,3.2,
+8DF5,2022-06-21,2.7,
+8EE0,2022-09-06,2.65,
+8EE1,2022-09-06,2.7,
+8EEU,2022-09-07,3.5,
+8EEV,2022-09-07,3.6,
+8GAB,2023-02-22,2.72,
+8J1Q,2023-04-13,3.3,
+8J26,2023-04-14,3.4,
+8T59,2023-06-12,2.0,
+8TS0,2023-08-10,1.7,
+8TTW,2023-08-15,2.96,
+8VRR,2024-01-22,2.36,
+8XGR,2023-12-15,3.2,
+8XSF,2024-01-09,2.16,
+8XSJ,2024-01-09,2.61,
+9JU1,2024-10-07,1.45,
+9KKU,2024-11-14,1.46,
+1FOE,2000-08-27,2.8,
+5H7D,2016-11-17,2.57,
+7V05,2022-05-09,3.4,
+8HA0,2022-10-26,2.62,
+8HAF,2022-10-26,3.25,
+8HAO,2022-10-26,3.76,
+8TOX,2023-08-04,2.3,
+5CTQ,2015-07-24,2.6,
+5CTR,2015-07-24,3.012,
+5CTT,2015-07-24,1.7,
+3Q1S,2010-12-17,2.15,
+3QG6,2011-01-24,2.5,
+3QJJ,2011-01-29,2.8049,
+3QJL,2011-01-30,2.7009,
+3QJP,2011-01-30,3.2986,
+3QSK,2011-02-21,1.75,
+3R8B,2011-03-23,2.95,
+3RAJ,2011-03-28,3.044,
+3RN2,2011-04-21,2.55,
+3RN5,2011-04-21,2.5,
+3S35,2011-05-17,2.2,
+3S36,2011-05-17,3.2,
+3S37,2011-05-17,2.7,
+3SE3,2011-06-10,4.0001,
+3SE4,2011-06-10,3.5001,
+3SQO,2011-07-05,2.7,
+3TBS,2011-08-08,2.49,
+3TBT,2011-08-08,2.3,
+3TBV,2011-08-08,2.1,
+3TBW,2011-08-08,2.15,
+3TBY,2011-08-08,2.5,
+3UX9,2011-12-04,2.8,
+3VW3,2012-07-30,2.5,
+3WFB,2013-07-18,2.7,
+3WFC,2013-07-18,2.5,
+3WFD,2013-07-18,2.3,
+3WFE,2013-07-18,2.49,
+3WLW,2013-11-15,3.088,
+3WSQ,2014-03-20,3.5,
+3X3F,2015-01-20,2.1,
+3ZKM,2013-01-23,1.85,
+3ZKN,2013-01-23,2.0,
+3ZKQ,2013-01-24,1.51,
+3ZKS,2013-01-24,2.11,
+3ZLQ,2013-02-04,2.1,
+3ZO0,2013-02-19,1.99,
+4ADF,2011-12-23,4.4,
+4ADQ,2012-01-02,4.5,
+4AEI,2012-01-10,2.3,
+4AG4,2012-01-24,2.8,
+4AZ8,2012-06-24,2.65,
+4BEL,2013-03-11,1.85,
+4BFB,2013-03-18,2.21,
+4C0U,2013-08-08,10.0,
+4C0Y,2013-08-08,16.0,
+4C10,2013-08-08,13.0,
+4C56,2013-09-10,2.9,
+4CKD,2014-01-03,13.0,
+4CMH,2014-01-15,1.53,
+4D9Q,2012-01-11,2.28,
+4D9R,2012-01-11,2.42,
+4DKE,2012-02-03,3.0,
+4DKF,2012-02-03,2.61,
+4DW2,2012-02-24,2.97,
+4E5X,2012-03-14,1.95,
+4EEF,2012-03-28,2.704,
+4EIG,2012-04-05,2.5,
+4EIZ,2012-04-06,2.2,
+4EJ1,2012-04-06,1.75,
+4F00,2012-05-03,1.95,
+4FQB,2012-06-25,2.69,
+4GRG,2012-08-24,4.24,
+4I0C,2012-11-16,1.95,
+4I13,2012-11-19,1.6,
+4I1N,2012-11-21,1.888,
+4I77,2012-11-30,1.9,
+4JN2,2013-03-14,1.71,
+4K3H,2013-04-10,2.45,
+4KRL,2013-05-16,2.849,
+4KRM,2013-05-16,2.655,
+4KRO,2013-05-16,3.054,
+4KRP,2013-05-16,2.823,
+4KUC,2013-05-21,2.787,
+4KZD,2013-05-29,2.186,
+4KZE,2013-05-29,2.404,
+4LEO,2013-06-26,2.64,
+4LGP,2013-06-28,2.4,
+4LGR,2013-06-28,1.65,
+4LGS,2013-06-28,2.7,
+4LHJ,2013-07-01,1.8,
+4LHQ,2013-07-01,2.3,
+4LXR,2013-07-30,2.2,
+4LXS,2013-07-30,3.3,
+4M3K,2013-08-06,1.48,
+4MJ5,2013-09-03,2.401,
+4MJ6,2013-09-03,2.57,
+4MXV,2013-09-26,3.2,
+4MXW,2013-09-26,3.6,
+4N1C,2013-10-03,1.7,
+4N1E,2013-10-04,2.23,
+4N1H,2013-10-04,3.0,
+4N90,2013-10-18,3.3,
+4NIK,2013-11-06,2.5,
+4NKD,2013-11-12,3.303,
+4NKM,2013-11-12,3.71,
+4NKO,2013-11-12,3.496,
+4NNX,2013-11-19,2.104,
+4NNY,2013-11-19,1.9,
+4NO0,2013-11-19,2.7,
+4NO2,2013-11-19,2.0,
+4NO3,2013-11-19,1.703,
+4NO5,2013-11-19,2.101,
+4NSK,2013-11-28,2.6,
+4OD2,2014-01-09,3.2,
+4PG9,2014-05-01,2.4,
+4PGB,2014-05-01,2.8,
+4PGC,2014-05-01,2.3,
+4PGD,2014-05-01,2.7,
+4PGE,2014-05-01,2.0,
+4PGJ,2014-05-02,2.6,
+4POU,2014-02-26,1.75,
+4Q9R,2014-05-01,3.12,
+4QNP,2014-06-18,2.8,
+4QWW,2014-07-17,2.7,
+4R9Y,2014-09-08,4.11,
+4RAV,2014-09-11,2.5,
+4RGM,2014-09-30,2.689,
+4RGN,2014-09-30,2.698,
+4RGO,2014-09-30,1.8,
+4TSA,2014-06-18,2.27,
+4TSB,2014-06-18,1.95,
+4TSC,2014-06-18,1.92,
+4V1D,2014-09-25,3.1,
+4WV1,2014-11-04,2.362,
+4XWG,2015-01-28,2.65,
+4XX1,2015-01-29,3.6,
+4YFD,2015-02-25,3.253,
+4YH7,2015-02-27,4.4,
+4YQX,2015-03-13,2.826,
+4YUE,2015-03-18,2.194,
+4Z5R,2015-04-02,3.0,
+4Z8F,2015-04-08,1.75,
+4Z95,2015-04-09,1.79,
+4Z9K,2015-04-10,1.5,
+4ZBN,2015-04-15,2.447,
+5AUM,2015-04-30,2.05,
+5BJT,2016-10-23,3.2,
+5BOZ,2015-05-27,3.1,
+5BV7,2015-06-04,2.45,
+5E08,2015-09-28,2.38,
+5E1H,2015-09-29,2.032,
+5E8E,2015-10-14,1.9,
+5EPM,2015-11-11,1.75,
+5F1K,2015-11-30,2.3,
+5F1O,2015-11-30,2.2,
+5F21,2015-12-01,1.9,
+5GKR,2016-07-05,2.1,
+5GMF,2016-07-14,2.5,
+5GMG,2016-07-14,2.6,
+5H30,2016-10-19,4.4,
+5H32,2016-10-20,12.0,
+5H37,2016-10-20,4.0,
+5H9E,2015-12-28,3.21,
+5H9F,2015-12-28,2.45,
+5HHV,2016-01-11,2.2,
+5HHX,2016-01-11,3.0,
+5HI3,2016-01-11,2.15,
+5HI4,2016-01-11,1.8,
+5HI5,2016-01-11,1.8,
+5IRO,2016-03-14,2.64,
+5J1A,2016-03-29,1.86,
+5J56,2016-04-01,1.8,
+5J57,2016-04-01,1.7,
+5KTZ,2016-07-12,4.3,
+5KU0,2016-07-12,5.3,
+5KU2,2016-07-12,5.3,
+5KWL,2016-07-18,4.8,
+5L0Q,2016-07-28,2.759,
+5SX4,2016-08-09,2.8,
+5SX5,2016-08-09,2.5,
+5TW2,2016-11-11,1.75,
+5TW5,2016-11-11,1.85,
+5U4L,2016-12-05,2.5,
+5U4M,2016-12-05,2.5,
+5U66,2016-12-07,1.7,
+5U8R,2016-12-14,3.00001618041,
+5UBM,2016-12-20,2.5,
+5UC6,2016-12-21,2.1,
+5UHY,2017-01-12,6.2,
+5UJ2,2017-01-16,2.9,
+5UMI,2017-01-27,3.23,
+5UOE,2017-01-31,3.8,
+5UTZ,2017-02-15,2.747,
+5UZ9,2017-02-25,3.4,
+5VB9,2017-03-28,1.7,
+5VJO,2017-04-19,2.43,
+5VJQ,2017-04-19,1.9,
+5VPG,2017-05-05,1.95,
+5VPH,2017-05-05,2.5,
+5VPL,2017-05-05,1.9,
+5VQM,2017-05-09,2.79,
+5VZL,2017-05-29,3.9,
+5W3E,2017-06-07,2.53,
+5W3L,2017-06-08,2.71,
+5W3M,2017-06-08,2.26,
+5W5X,2017-06-16,2.502,
+5XLO,2017-05-11,3.8,
+5XLP,2017-05-11,4.2,
+5XZB,2017-07-12,2.13,
+5XZE,2017-07-12,2.177,
+5XZG,2017-07-12,1.828,
+5Y0A,2017-07-15,22.0,
+5Y32,2017-07-27,2.701,
+5Y7Z,2017-08-18,2.804,
+5Y80,2017-08-18,2.5,
+6AD0,2018-07-28,3.9,
+6ARU,2017-08-23,3.2,
+6B14,2017-09-16,1.64,
+6B3K,2017-09-22,2.09,
+6B3S,2017-09-23,2.8,
+6B45,2017-09-25,3.5,
+6B47,2017-09-25,3.2,
+6B48,2017-09-25,3.6,
+6B7Z,2017-10-05,6.5,
+6BF7,2017-10-26,6.5,
+6BF9,2017-10-26,7.2,
+6BGT,2017-10-29,2.7,
+6BSP,2017-12-04,4.7,
+6C9U,2018-01-28,2.09,
+6DB8,2018-05-02,1.86541345549,
+6DB9,2018-05-02,2.025,
+6DN5,2018-06-06,2.4,
+6DN6,2018-06-06,1.59,
+6DN7,2018-06-06,1.4,
+6DN8,2018-06-06,1.75,
+6DXG,2018-06-28,1.905,
+6DXL,2018-06-29,2.45,
+6IV6,2018-12-02,3.6,
+6J6Y,2019-01-16,2.15,
+6JB2,2019-01-25,1.5,
+6JB5,2019-01-25,1.55,
+6JB8,2019-01-25,1.65,
+6JSZ,2019-04-08,1.53,
+6L62,2019-10-25,7.2,
+6LXI,2020-02-11,2.5,
+6LXJ,2020-02-11,2.903,
+6LXK,2020-02-11,3.608,
+6MID,2018-09-19,4.0,
+6MJQ,2018-09-21,3.0,
+6MTJ,2018-10-19,2.336,
+6MTN,2018-10-20,2.5,
+6MU6,2018-10-22,2.551,
+6MU7,2018-10-22,2.501,
+6MU8,2018-10-22,2.993,
+6MUF,2018-10-23,2.91,
+6MUG,2018-10-23,2.954,
+6MUI,2018-10-23,7.7,
+6MW9,2018-10-29,7.3,
+6MWC,2018-10-29,7.5,
+6MWN,2018-10-29,2.838,
+6MWV,2018-10-30,7.3,
+6MWX,2018-10-30,8.2,
+6MXE,2018-10-30,2.47,
+6NE0,2018-12-15,3.4,
+6NIG,2018-12-27,2.35,
+6NM7,2019-01-10,2.426,
+6NM8,2019-01-10,2.792,
+6O1F,2019-02-19,2.15,
+6O6V,2019-03-07,2.35,
+6O6X,2019-03-07,2.11,
+6O71,2019-03-07,2.55,
+6O75,2019-03-07,2.6,
+6O78,2019-03-07,2.8,
+6O7B,2019-03-07,2.4,
+6O7E,2019-03-07,3.2,
+6O7I,2019-03-07,3.2,
+6OGE,2019-04-02,4.36,
+6OV0,2019-05-06,2.8,
+6OY4,2019-05-14,2.45,
+6P4A,2019-05-27,2.2,
+6P4B,2019-05-27,1.9,
+6Q0B,2019-08-01,3.4,
+6U36,2019-08-21,2.7,
+6U38,2019-08-21,2.73,
+6U8D,2019-09-04,1.807,
+6U8K,2019-09-05,2.75,
+6VMJ,2020-01-28,2.95,
+6VMK,2020-01-28,3.01,
+6VVU,2020-02-18,3.0,
+6W09,2020-02-29,5.3,
+6W1C,2020-03-04,5.3,
+6W1X,2020-03-04,3.9,
+6W7S,2020-03-19,2.25,
+6WDS,2020-04-01,2.9,
+6WDT,2020-04-01,3.1,
+6WH9,2020-04-07,2.75,
+6WIO,2020-04-10,2.17,
+6WIR,2020-04-10,2.96,
+6WJL,2020-04-14,3.3,
+6WVZ,2020-05-07,3.1,
+6X5M,2020-05-26,2.5,
+6X5N,2020-05-26,3.3,
+6XJD,2020-06-23,6.8,
+6XJQ,2020-06-24,1.708,
+6XJW,2020-06-24,1.918,
+6XJY,2020-06-24,2.156,
+6XJZ,2020-06-24,2.488,
+6XM2,2020-06-29,1.91,
+6XOB,2020-07-06,8.5,
+7C80,2020-05-28,3.7,
+7C81,2020-05-28,3.1,
+7CQC,2020-08-10,2.5,
+7CQD,2020-08-10,3.2,
+7CR6,2020-08-12,3.72,
+7CR8,2020-08-12,3.7,
+7CVY,2020-08-27,5.2,
+7CVZ,2020-08-27,4.7,
+7CW0,2020-08-27,5.9,
+7CW2,2020-08-27,4.5,
+7CW3,2020-08-27,9.4,
+7D5B,2020-09-25,1.31,
+7D5U,2020-09-28,2.04,
+7DMQ,2020-12-05,3.06,
+7DQ7,2020-12-22,3.2,
+7DWT,2021-01-18,19.0,
+7DWU,2021-01-18,19.0,
+7E3M,2021-02-09,2.8,
+7ECV,2021-03-13,3.43,
+7ELM,2021-04-12,2.88,
+7FCZ,2021-07-15,2.21,
+7FD0,2021-07-15,2.0,
+7JHG,2020-07-20,3.47,
+7JHH,2020-07-20,3.92,
+7JHY,2020-07-21,3.9,
+7JKQ,2020-07-28,3.3,
+7JN7,2020-08-04,3.3,
+7JR7,2020-08-11,3.3,
+7JTN,2020-08-18,3.1,
+7JTQ,2020-08-18,3.5,
+7KCR,2020-10-07,4.0,
+7KPB,2020-11-10,3.0,
+7LA8,2021-01-06,1.8965,
+7LEX,2021-01-15,3.6,
+7LEY,2021-01-15,3.05,
+7LEZ,2021-01-15,4.15,
+7LF0,2021-01-15,3.68,
+7LF1,2021-01-15,4.04,
+7LF2,2021-01-15,3.72,
+7LKB,2021-02-02,1.8,
+7LKG,2021-02-02,2.02,
+7M3L,2021-03-18,3.2,
+7M3N,2021-03-18,2.4,
+7MDP,2021-04-05,1.96,
+7MHY,2021-04-16,2.7,
+7MHZ,2021-04-16,3.2,
+7MK1,2021-04-21,1.9,
+7MLH,2021-04-28,2.1,
+7MLX,2021-04-29,2.09,
+7MNL,2021-05-01,3.95,
+7MNO,2021-05-01,6.73,
+7N0A,2021-05-25,3.1,
+7RAH,2021-07-01,2.6,
+7RP2,2021-08-03,2.2,
+7RP3,2021-08-03,2.0,
+7RT9,2021-08-12,1.9,
+7RTA,2021-08-12,2.6,
+7SBD,2021-09-24,3.04,
+7SBG,2021-09-24,3.34,
+7SFV,2021-10-04,4.0,
+7SFW,2021-10-04,3.2,
+7SGM,2021-10-06,2.0,
+7SJN,2021-10-18,3.4,
+7SJO,2021-10-18,3.3,
+7SO5,2021-10-29,1.797,
+7SO7,2021-10-29,3.59,
+7SZU,2021-11-29,2.24,
+7T9U,2021-12-20,2.46,
+7T9V,2021-12-20,2.68,
+7TGF,2022-01-07,1.347,
+7TGI,2022-01-07,2.104,
+7TH2,2022-01-10,1.838,
+7TH3,2022-01-10,2.292,
+7TLY,2022-01-19,3.0,
+7TLZ,2022-01-19,3.3,
+7TNX,2022-01-22,3.54,
+7TNY,2022-01-22,3.2,
+7TNZ,2022-01-22,3.54,
+7TO0,2022-01-22,3.5,
+7TO1,2022-01-22,3.66,
+7TO2,2022-01-22,3.2,
+7TQS,2022-01-26,3.9,
+7TQT,2022-01-27,4.1,
+7TQU,2022-01-27,3.8,
+7U0Y,2022-02-19,2.66,
+7U5B,2022-03-02,2.371,
+7UBZ,2022-03-15,1.75,
+7UTP,2022-04-27,3.8,
+7UTR,2022-04-27,3.7,
+7UTS,2022-04-27,3.6,
+7UTU,2022-04-27,3.0,
+7UTV,2022-04-27,3.0,
+7V0N,2022-05-10,5.9,
+7V0O,2022-05-10,6.6,
+7V0P,2022-05-10,5.2,
+7V3G,2021-08-10,3.3,
+7V3H,2021-08-10,3.6,
+7V3I,2021-08-10,4.4,
+7V3J,2021-08-10,4.9,
+7V5N,2021-08-17,1.7,
+7W71,2021-12-02,3.2,
+7WM4,2022-01-14,3.2,
+7WV3,2022-02-09,2.26,
+7WV4,2022-02-09,3.35,
+7WV5,2022-02-09,3.1,
+7WVE,2022-02-10,3.11,
+7WVF,2022-02-10,3.91,
+7WVJ,2022-02-10,3.26,
+7XSO,2022-05-15,3.01,
+7XSP,2022-05-15,2.89,
+7XSQ,2022-05-15,2.88,
+7XSR,2022-05-15,2.97,
+7XSS,2022-05-15,3.2,
+7XT4,2022-05-16,3.08,
+7Y8T,2022-06-24,2.9,
+7Y8Y,2022-06-24,3.0,
+7YRU,2022-08-10,2.6,
+8B7W,2022-10-03,2.85,
+8CXG,2022-05-21,3.2,
+8CXH,2022-05-21,3.2,
+8CXI,2022-05-21,3.4,
+8D29,2022-05-28,1.81,
+8D3A,2022-06-01,2.9,
+8D7E,2022-06-07,2.93,
+8DB4,2022-06-14,2.3,
+8DCM,2022-06-16,2.5,
+8DCN,2022-06-16,2.6,
+8DED,2022-06-20,4.1,
+8DEF,2022-06-20,4.2,
+8DJK,2022-06-30,3.33,
+8DJM,2022-07-01,3.23,
+8DK7,2022-07-04,2.46,
+8DP0,2022-07-14,2.96,
+8DP3,2022-07-14,1.91,
+8E1M,2022-08-10,2.9,
+8E8L,2022-08-25,3.13,
+8E8R,2022-08-25,2.66,
+8E8S,2022-08-25,2.73,
+8E8X,2022-08-26,2.91,
+8E8Y,2022-08-26,2.5,
+8E8Z,2022-08-26,3.15,
+8EJ4,2022-09-16,3.4,
+8EZ3,2022-10-31,2.5,
+8EZ7,2022-10-31,2.6,
+8EZ8,2022-10-31,2.78,
+8FE3,2022-12-05,10.2,
+8FE4,2022-12-05,9.8,
+8FFJ,2022-12-08,7.5,
+8FGX,2022-12-13,2.62,
+8G23,2023-02-03,2.71,
+8GDG,2023-03-05,,
+8GDH,2023-03-05,,
+8GIM,2023-03-14,2.63,
+8GIN,2023-03-14,2.75,
+8GIP,2023-03-14,2.7,
+8GQV,2022-08-31,2.4,
+8GQW,2022-08-31,2.48,
+8GSC,2022-09-06,3.4,
+8GSD,2022-09-06,3.1,
+8GSF,2022-09-06,3.6,
+8IPC,2023-03-14,2.2,
+8J6K,2023-04-26,3.12,
+8JN2,2023-06-06,4.1,
+8JN3,2023-06-06,5.4,
+8JN4,2023-06-06,3.5,
+8JN5,2023-06-06,3.6,
+8JN6,2023-06-06,9.8,
+8JN7,2023-06-06,11.0,
+8K33,2023-07-14,2.13,
+8K3A,2023-07-14,2.74,
+8K3L,2023-07-16,2.3,
+8SE5,2023-04-08,1.43,
+8SE6,2023-04-08,1.36,
+8SH5,2023-04-13,2.75,
+8SML,2023-04-26,3.3,
+8SMM,2023-04-26,3.2,
+8SMN,2023-04-26,3.2,
+8SMP,2023-04-26,3.4,
+8SQH,2023-05-04,3.69,
+8STH,2023-05-10,1.97,
+8STI,2023-05-10,1.72,
+8SV1,2023-05-15,3.5,
+8SXP,2023-05-23,2.9,
+8T29,2023-06-05,3.13,
+8T2A,2023-06-05,3.17,
+8T2B,2023-06-05,3.18,
+8T2O,2023-06-06,3.29,
+8T66,2023-06-15,1.85,
+8TFH,2023-07-11,3.29,
+8U0J,2023-08-29,3.1,
+8U0U,2023-08-29,3.04,
+8U0W,2023-08-29,2.99,
+8U3K,2023-09-07,2.5,
+8UKV,2023-10-15,2.94,
+8V52,2023-11-30,2.5,
+8VGH,2023-12-27,2.9,
+8VGI,2023-12-27,2.7,
+8VGJ,2023-12-27,2.5,
+8VGK,2023-12-27,2.4,
+8VGP,2023-12-27,2.7,
+8VGQ,2023-12-27,2.8,
+8VK1,2024-01-08,3.05,
+8VM8,2024-01-13,1.54,
+8VM9,2024-01-13,2.2,
+8VMA,2024-01-13,2.54,
+8VMB,2024-01-13,2.97,
+8VRS,2024-01-22,2.47,
+8VUH,2024-01-29,4.42,
+8VXA,2024-02-03,2.79,
+8VXC,2024-02-04,2.93,
+8W2S,2024-02-21,3.4,
+8WE4,2023-09-17,2.91,
+8WEO,2023-09-18,1.5,
+8Y0Q,2024-01-23,2.44,
+8Y0R,2024-01-23,2.52,
+8YE6,2024-02-22,2.95,
+8YE9,2024-02-22,3.43,
+8YVJ,2024-03-28,1.65,
+8YVO,2024-03-28,2.1,
+8ZM3,2024-05-22,3.1,
+8ZOL,2024-05-28,2.55,
+9BF5,2024-04-16,3.07,
+9BGK,2024-04-19,3.28,
+9C6Q,2024-06-08,3.18,
+9JUB,2024-10-07,3.1,
+1A3R,1998-01-23,2.1,
+1AFV,1997-03-14,3.7,
+1CDC,1995-05-23,2.0,
+1D5M,1999-10-07,2.0,
+1D5X,1999-10-12,2.45,
+1D5Z,1999-10-12,2.0,
+1D6E,1999-10-13,2.45,
+1EO8,2000-03-22,2.8,
+1F58,1998-10-21,2.0,
+1FCG,1999-04-07,2.0,
+1FFN,2000-07-25,2.7,
+1FFO,2000-07-25,2.65,
+1FFP,2000-07-25,2.6,
+1FRG,1994-01-17,2.8,
+1G1Q,2000-10-13,2.4,
+1G1R,2000-10-13,3.4,
+1G1S,2000-10-13,1.9,
+1G1T,2000-10-13,1.5,
+1G9M,2000-11-24,2.2,
+1G9N,2000-11-25,2.9,
+1H9V,2001-03-21,3.0,
+1IM3,2001-05-09,2.2,
+1IQD,2001-07-21,2.0,
+1J5O,2002-05-24,3.5,
+1JH5,2001-06-27,3.0,
+1JMM,2001-07-19,2.4,
+1KEN,2001-11-16,3.5,
+1KG0,2001-11-25,2.65,
+1N5Y,2002-11-07,3.1,
+1N6Q,2002-11-11,3.0,
+1O77,2002-10-24,3.2,
+1PQZ,2003-06-19,2.1,
+1QFU,1999-04-14,2.8,
+1R0A,2003-09-19,2.8,
+1RZJ,2003-12-24,2.2,
+1RZK,2003-12-24,2.9,
+1TJG,2004-06-04,2.0,
+1TJH,2004-06-04,2.1,
+1TJI,2004-06-04,2.2,
+1TQB,2004-06-17,2.55,
+1TQC,2004-06-17,2.8,
+1TWQ,2004-07-01,2.3,
+1UJ3,2003-07-25,2.1,
+1XIW,2004-09-22,1.9,
+1XU6,2004-10-25,,
+1YJD,2005-01-14,2.7,
+1YYL,2005-02-25,2.75,
+1YYM,2005-02-25,2.2,
+1Z3G,2005-03-12,3.3,
+1Z6I,2005-03-22,2.5,
+1ZA3,2005-04-05,3.35,
+1ZHN,2005-04-26,2.8,
+1ZTX,2005-05-27,2.5,
+1ZWI,2005-06-03,2.5,
+1ZXG,2005-06-08,,
+1ZXH,2005-06-08,,
+2ADF,2005-07-20,1.9,
+2ATK,2005-08-25,2.5,
+2AXF,2005-09-05,1.8,
+2AXG,2005-09-05,2.0,
+2B4C,2005-09-23,3.3,
+2B9L,2005-10-12,2.0,
+2BOB,2005-04-09,2.76,
+2BOC,2005-04-09,3.01,
+2D31,2005-09-23,3.2,
+2D8I,2005-12-06,,
+2DD8,2006-01-24,2.3,
+2E8D,2007-01-19,,
+2ESG,2005-10-26,,
+2FSE,2006-01-22,3.1,
+2FWO,2006-02-02,2.6,
+2GI9,2006-03-28,1.14,
+2I5Y,2006-08-26,2.2,
+2I60,2006-08-26,2.4,
+2I9L,2006-09-05,3.1,
+2IKQ,2006-10-02,2.609,
+2JK5,2008-08-15,2.4,
+2JWG,2007-10-12,,
+2JWH,2007-10-12,,
+2K4F,2008-06-07,,
+2KLU,2009-07-08,,
+2KXA,2010-04-29,,
+2LK9,2011-10-07,,
+2NXY,2006-11-20,2.0,
+2NXZ,2006-11-20,2.04,
+2NY0,2006-11-20,2.2,
+2NY1,2006-11-20,1.99,
+2NY2,2006-11-20,2.0,
+2NY3,2006-11-20,2.0,
+2NY4,2006-11-20,2.0,
+2NY5,2006-11-20,2.5,
+2NY6,2006-11-20,2.8,
+2NY7,2006-11-20,2.3,
+2O39,2006-12-01,2.85,
+2OAY,2006-12-18,2.35,
+2PLP,2007-04-20,,
+2QAD,2007-06-14,3.3,
+2QHR,2007-07-02,2.0,
+2QKI,2007-07-11,2.4,
+2QQH,2007-07-26,2.5,
+2R29,2007-08-24,3.0,
+2R69,2007-09-05,3.8,
+2UZI,2007-04-27,2.0,
+2VC2,2007-09-18,3.1,
+2VDK,2007-10-10,2.8,
+2VDL,2007-10-10,2.75,
+2VDM,2007-10-10,2.9,
+2VDN,2007-10-10,2.9,
+2VDO,2007-10-10,2.51,
+2VDP,2007-10-10,2.8,
+2VDQ,2007-10-10,2.59,
+2VDR,2007-10-10,2.4,
+2W0F,2008-08-14,2.4,
+2WY3,2009-11-11,1.8,
+2XQY,2010-09-08,2.05,
+2XT1,2010-10-03,1.32,
+2XV6,2010-10-22,1.89,
+2XWT,2010-11-05,1.9,
+2Y6S,2011-01-25,2.8,
+2YPL,2012-10-30,2.4,
+2Z22,2007-05-17,2.0,
+2ZJS,2008-03-08,3.2,
+3BGF,2007-11-26,3.0,
+3BN3,2007-12-13,2.099,
+3BSZ,2007-12-27,3.38,
+3CFI,2008-03-03,2.58,
+3CSY,2008-04-10,3.4,
+3EJY,2008-09-18,3.2,
+3EJZ,2008-09-18,2.9,
+3EOA,2008-09-26,2.8,
+3EOB,2008-09-26,3.6,
+3FF7,2008-12-02,1.8,
+3FF8,2008-12-02,2.0,
+3FKU,2008-12-17,3.2,
+3G9A,2009-02-13,1.614,
+3GBM,2009-02-20,2.7,
+3GBN,2009-02-20,2.2,
+3GKW,2009-03-11,2.5,
+3H0T,2009-04-10,1.89,
+3HI1,2009-05-18,2.9,
+3HI6,2009-05-19,2.3,
+3HPL,2009-06-04,3.2,
+3I50,2009-07-03,3.0,
+3INB,2009-08-12,3.1,
+3J5M,2013-10-26,5.8,
+3J70,2014-04-22,20.0,
+3JCB,2015-11-25,,
+3JCC,2015-11-25,,
+3K1K,2009-09-28,2.15,
+3LZF,2010-03-01,2.8,
+3LZG,2010-03-01,2.6,
+3MOP,2010-04-23,3.4,
+3NGB,2010-06-11,2.68,
+3O41,2010-07-26,1.95,
+3O45,2010-07-26,2.872,
+3O8E,2010-08-03,2.84,
+3OGO,2010-08-17,2.8,
+3OR6,2010-09-06,2.7,
+3OR7,2010-09-06,2.3,
+3P9W,2010-10-18,2.41,
+3PNW,2010-11-19,2.05,
+3Q3G,2010-12-21,2.7,
+3QA3,2011-01-10,3.0,
+3QA8,2011-01-10,3.6,
+3QT2,2011-02-22,2.55,
+3RHW,2011-04-12,3.26,
+3RI5,2011-04-12,3.4,
+3RIA,2011-04-13,3.8,
+3RIF,2011-04-13,3.345,
+3RJQ,2011-04-15,2.601,
+3RKD,2011-04-18,1.9,
+3RZF,2011-05-11,4.0,
+3S88,2011-05-27,3.351,
+3SDY,2011-06-09,2.85,
+3SE8,2011-06-10,1.895,
+3SE9,2011-06-10,2.0,
+3SOB,2011-06-30,1.9,
+3TYG,2011-09-25,3.25,
+3U7Y,2011-10-14,2.4478,
+3UAJ,2011-10-21,3.232,
+3UBE,2011-10-24,2.15,
+3UBJ,2011-10-24,2.25,
+3UBN,2011-10-24,2.5079,
+3UBQ,2011-10-24,2.0,
+3UC0,2011-10-25,2.71,
+3VE0,2012-01-06,3.353,
+3VI3,2011-09-21,2.9,
+3VI4,2011-09-21,2.9,
+3VRL,2012-04-12,3.2,
+3W9E,2013-04-03,2.3,
+3WE1,2013-06-27,2.278,
+3WHE,2013-08-25,4.0,
+3ZDX,2012-12-03,2.45,
+3ZTJ,2011-07-08,3.41,
+3ZTN,2011-07-12,3.001,
+4BZ1,2013-07-23,2.15,
+4CC8,2013-10-18,6.0,
+4DAG,2012-01-12,3.3904,
+4DGV,2012-01-26,1.805,
+4DGY,2012-01-27,1.798,
+4DVR,2012-02-23,2.5,
+4EMZ,2012-04-12,2.9,
+4EN2,2012-04-12,2.58,
+4ETQ,2012-04-24,2.1,
+4F2M,2012-05-08,3.0,
+4FFV,2012-06-01,2.4,
+4FFW,2012-06-01,2.9,
+4FFY,2012-06-01,2.5,
+4FFZ,2012-06-01,3.8,
+4FP8,2012-06-21,2.947,
+4FQI,2012-06-25,1.71,
+4FQJ,2012-06-25,2.5,
+4FQK,2012-06-25,5.65,
+4FQR,2012-06-25,4.1,
+4FQV,2012-06-25,5.75,
+4FQY,2012-06-25,5.253,
+4GFT,2012-08-03,1.6,
+4GMS,2012-08-16,2.95,
+4GXU,2012-09-04,3.294,
+4H8W,2012-09-24,1.85,
+4HF5,2012-10-04,3.004,
+4HFU,2012-10-05,3.106,
+4HG4,2012-10-06,3.2,
+4HIX,2012-10-12,2.204,
+4HKJ,2012-10-15,3.0,
+4HKX,2012-10-15,2.5,
+4HLZ,2012-10-17,2.9,
+4HPO,2012-10-24,1.694,
+4HPY,2012-10-24,1.5,
+4HSA,2012-10-29,3.15,
+4I3R,2012-11-26,3.0,
+4I3S,2012-11-26,2.85,
+4J6R,2013-02-11,1.64,
+4JAN,2013-02-18,3.15,
+4JB9,2013-02-19,2.6,
+4JDT,2013-02-25,3.26,
+4JKP,2013-03-11,2.82,
+4JM2,2013-03-13,3.1,
+4JO1,2013-03-16,2.033,
+4JO2,2013-03-16,2.5,
+4JO3,2013-03-16,2.6,
+4JO8,2013-03-18,3.2,
+4JPK,2013-03-19,2.4,
+4JPV,2013-03-19,2.827,
+4JPW,2013-03-19,2.904,
+4JR9,2013-03-21,2.6,
+4JRE,2013-03-21,2.8,
+4JZJ,2013-04-03,2.801,
+4JZN,2013-04-03,2.05,
+4JZO,2013-04-03,2.22,
+4L4T,2013-06-09,2.0,
+4L4V,2013-06-09,1.9,
+4L5F,2013-06-11,2.45,
+4LCW,2013-06-24,2.4,
+4LMQ,2013-07-10,2.773,
+4LSP,2013-07-23,2.15,
+4LSQ,2013-07-23,2.25,
+4LSR,2013-07-23,2.28,
+4LSS,2013-07-23,2.59,
+4LST,2013-07-23,2.55,
+4LSU,2013-07-23,2.3,
+4LSV,2013-07-23,3.0,
+4LVN,2013-07-26,2.25,
+4LVO,2013-07-26,2.26,
+4M5Z,2013-08-08,2.25,
+4M7L,2013-08-12,3.4,
+4MHH,2013-08-29,3.564,
+4MHJ,2013-08-29,6.98,
+4NCO,2013-10-24,4.7,
+4NM8,2013-11-14,4.0041,
+4NNP,2013-11-18,2.69,
+4NQV,2013-11-25,2.39,
+4NQX,2013-11-26,2.0,
+4NZR,2013-12-12,1.65,
+4NZT,2013-12-12,2.497,
+4O58,2013-12-19,2.7501,
+4O5I,2013-12-19,6.501,
+4OII,2014-01-19,3.0,
+4OLU,2014-01-25,2.202,
+4OLV,2014-01-25,2.5,
+4OLW,2014-01-25,2.709,
+4OLX,2014-01-25,2.2,
+4OLY,2014-01-25,2.351,
+4OLZ,2014-01-25,2.1,
+4OM0,2014-01-25,2.289,
+4OM1,2014-01-25,2.131,
+4OQT,2014-02-10,3.23,
+4ORZ,2014-02-12,2.0,
+4OT1,2014-02-13,2.11,
+4P59,2014-03-15,3.4,
+4P9H,2014-04-04,3.0,
+4PDC,2014-04-17,1.991,
+4PLK,2014-05-18,4.0,
+4PY8,2014-03-26,2.91,
+4Q0X,2014-04-02,2.9,
+4QKX,2014-06-10,3.3,
+4QYZ,2014-07-26,3.0303,
+4RFN,2014-09-26,3.21,
+4RWY,2014-12-08,2.128,
+4RX4,2014-12-08,3.45,
+4S1Q,2015-01-14,2.4,
+4TNV,2014-06-05,3.6,
+4TNW,2014-06-05,3.2,
+4TVP,2014-06-27,3.1,
+4UBD,2014-08-12,3.5,
+4UF7,2015-03-13,1.7,
+4UTB,2014-07-18,3.85,
+4UUJ,2014-07-29,2.4,
+4WEB,2014-09-09,2.4,
+4WJK,2014-09-30,1.85,
+4WK0,2014-10-01,1.78,
+4WK2,2014-10-01,2.5,
+4WK4,2014-10-01,2.5,
+4X42,2014-12-02,2.78,
+4XHJ,2015-01-05,3.156,
+4XI5,2015-01-06,3.9,
+4XMK,2015-01-14,3.179,
+4XMM,2015-01-14,7.384,
+4XNM,2015-01-15,2.51,
+4XNQ,2015-01-15,2.001,
+4XRC,2015-01-20,2.74,
+4XVS,2015-01-27,1.9,
+4XVT,2015-01-28,1.69,
+4Y5V,2015-02-12,2.604,
+4Y5X,2015-02-12,3.15,
+4Y5Y,2015-02-12,2.85,
+4YBL,2015-02-18,3.1,
+4YBQ,2015-02-19,3.27,
+4YC2,2015-02-19,3.02,
+4YE4,2015-02-23,2.72,
+4YJZ,2015-03-03,2.72,
+4YK4,2015-03-03,2.8,
+4YWG,2015-03-20,2.998,
+4Z7N,2015-04-07,2.599,
+4Z7O,2015-04-07,2.85,
+4Z7Q,2015-04-07,2.7,
+4ZFF,2015-04-21,2.75,
+4ZFG,2015-04-21,2.27,
+4ZPT,2015-05-08,2.591,
+4ZPV,2015-05-08,3.2,
+4ZXB,2015-05-20,3.3,
+5A8H,2015-07-15,23.0,
+5AWW,2015-07-10,2.724,
+5BO1,2015-05-26,2.56,
+5BXF,2015-06-08,2.851,
+5C0R,2015-06-12,3.188,
+5C0S,2015-06-12,4.3,
+5CAY,2015-06-30,3.0,
+5CEZ,2015-07-08,3.031,
+5CJB,2015-07-14,2.398,
+5CJQ,2015-07-14,3.6,
+5CJS,2015-07-15,4.3,
+5CJX,2015-07-15,3.584,
+5DMI,2015-09-08,3.69,
+5DMJ,2015-09-08,2.79,
+5DO2,2015-09-10,2.409,
+5EN2,2015-11-09,1.821,
+5EOQ,2015-11-10,1.95,
+5EOR,2015-11-10,2.27,
+5ERW,2015-11-15,2.9,
+5F3B,2015-12-02,1.76,
+5F3H,2015-12-02,2.7,
+5FCU,2015-12-15,1.85,
+5FHC,2015-12-21,6.704,
+5GMQ,2016-07-15,2.703,
+5GZN,2016-09-29,3.0,
+5GZO,2016-09-29,2.755,
+5H35,2016-10-20,2.642,
+5H77,2016-11-17,3.197,
+5HDB,2016-01-05,2.7012,
+5HDQ,2016-01-05,1.83,
+5HJ3,2016-01-12,3.3,
+5IES,2016-02-25,2.16,
+5IF0,2016-02-25,2.44,
+5IHL,2016-02-29,3.3,
+5J3H,2016-03-30,3.27,
+5JHL,2016-04-21,3.0,
+5JS9,2016-05-07,6.918,
+5JSA,2016-05-07,6.308,
+5JYL,2016-05-14,2.55,
+5JYM,2016-05-14,2.45,
+5JZI,2016-05-16,2.5,
+5KEL,2016-06-09,4.3,
+5KEM,2016-06-09,5.5,
+5KEN,2016-06-09,4.3,
+5KTE,2016-07-11,3.941,
+5KVD,2016-07-14,1.65,
+5KVE,2016-07-14,1.7,
+5KVF,2016-07-14,1.4,
+5KVG,2016-07-14,1.4,
+5KZP,2016-07-25,2.262,
+5LBS,2016-06-17,2.41,
+5LCV,2016-06-22,2.64,
+5N09,2017-02-02,3.9,
+5N0A,2017-02-02,3.9,
+5T3X,2016-08-26,3.9,
+5T3Z,2016-08-26,3.5,
+5TJW,2016-10-05,3.231,
+5TOJ,2016-10-17,3.3,
+5TOK,2016-10-17,3.8,
+5TZN,2016-11-22,2.6,
+5U1F,2016-11-28,6.8,
+5U3J,2016-12-02,2.74,
+5U3K,2016-12-02,2.637,
+5U3L,2016-12-02,2.165,
+5U3M,2016-12-02,2.418,
+5U3N,2016-12-02,2.0,
+5U3O,2016-12-02,1.761,
+5U68,2016-12-07,3.083,
+5U7M,2016-12-12,3.025,
+5U7O,2016-12-12,3.031,
+5UDC,2016-12-26,3.45,
+5UDD,2016-12-26,4.3,
+5UG0,2017-01-06,3.4,
+5UGY,2017-01-10,2.801,
+5UJZ,2017-01-19,4.8,
+5UK0,2017-01-19,4.8,
+5UK1,2017-01-19,4.8,
+5UK2,2017-01-19,4.8,
+5UM8,2017-01-26,3.935,
+5UQY,2017-02-08,3.6,
+5USH,2017-02-13,2.3,
+5USL,2017-02-13,2.9,
+5UTY,2017-02-15,3.412,
+5V2A,2017-03-03,4.656,
+5V6L,2017-03-17,2.549,
+5V6M,2017-03-17,1.9,
+5V7J,2017-03-20,2.907,
+5V8L,2017-03-22,4.3,
+5V8M,2017-03-22,4.4,
+5VGJ,2017-04-11,3.456,
+5VIY,2017-04-17,6.2,
+5VJ6,2017-04-18,11.5,
+5VK2,2017-04-20,3.201,
+5VK6,2017-04-21,2.25,
+5VKE,2017-04-21,2.37,
+5VKH,2017-04-21,2.25,
+5VOB,2017-05-02,3.02,
+5VOC,2017-05-02,3.99,
+5VOD,2017-05-02,5.9,
+5W08,2017-05-30,2.6,
+5W0D,2017-05-30,1.899,
+5W0K,2017-05-31,3.1,
+5W1K,2017-06-03,3.99,
+5W1M,2017-06-03,3.91,
+5W23,2017-06-05,3.4,
+5W2B,2017-06-06,2.25,
+5W4L,2017-06-12,2.92,
+5W6D,2017-06-16,3.202,
+5W6G,2017-06-16,2.79,
+5WN9,2017-07-31,1.551,
+5WNA,2017-07-31,2.4,
+5WNB,2017-07-31,2.4,
+5X2M,2017-02-02,2.206,
+5X2N,2017-02-02,2.2,
+5X2O,2017-02-02,2.6,
+5X2P,2017-02-02,2.608,
+5X2Q,2017-02-02,2.6,
+5XBM,2017-03-20,3.501,
+5XHV,2017-04-24,3.35,
+5Y11,2017-07-19,2.1,
+5Y9C,2017-08-24,3.443,
+5Y9F,2017-08-24,3.35,
+5YHL,2017-09-28,4.2,
+5YWY,2017-11-30,3.2,
+6A0Z,2018-06-06,2.329,
+6A4K,2018-06-20,3.15,
+6AOD,2017-08-15,1.8,
+6B0N,2017-09-14,3.4,
+6B3M,2017-09-22,3.92,
+6B44,2017-09-25,2.9,
+6B46,2017-09-25,3.1,
+6B70,2017-10-03,3.7,
+6B9J,2017-10-10,2.9,
+6BCK,2017-10-20,2.7,
+6BF4,2017-10-25,2.382,
+6BLH,2017-11-10,2.0,
+6BLI,2017-11-10,2.12,
+6BP2,2017-11-21,3.172,
+6BRB,2017-11-30,2.82,
+6CE0,2018-02-09,4.602,
+6CMG,2018-03-05,2.7,
+6CMI,2018-03-05,2.72,
+6CVK,2018-03-28,2.38,
+6CWD,2018-03-30,3.33,
+6CWT,2018-03-30,3.151,
+6CXC,2018-04-02,3.9,
+6DFG,2018-05-14,4.42,
+6DFH,2018-05-14,3.85,
+6DZV,2018-07-05,4.2,
+6DZW,2018-07-05,4.3,
+6DZY,2018-07-05,4.1,
+6DZZ,2018-07-05,3.6,
+6E3H,2018-07-14,2.9,
+6E4X,2018-07-18,2.25,
+6E56,2018-07-19,2.0,
+6EA5,2018-08-02,4.75,
+6EA7,2018-08-02,4.25,
+6IEA,2018-09-13,2.0,
+6IEB,2018-09-13,2.409,
+6IEC,2018-09-13,3.2,
+6IEK,2018-09-14,2.7,
+6IVZ,2018-12-04,2.4,
+6IW0,2018-12-04,3.6,
+6IW2,2018-12-04,2.9,
+6J5D,2019-01-10,1.8,
+6J5F,2019-01-10,1.801,
+6J5G,2019-01-10,3.291,
+6JMQ,2019-03-13,3.31,
+6JMR,2019-03-13,4.1,
+6JP7,2019-03-26,1.909,
+6KRZ,2019-08-22,3.05,
+6KS0,2019-08-22,2.79,
+6KS1,2019-08-22,2.4,
+6KTR,2019-08-28,2.59775753879,
+6LBH,2019-11-14,3.7,
+6M3B,2020-03-03,2.2,
+6M3C,2020-03-03,3.7,
+6MAM,2018-08-28,4.1,
+6MFP,2018-09-11,3.0,
+6MFT,2018-09-12,2.315,
+6MG7,2018-09-13,2.91,
+6MJZ,2018-09-24,4.3,
+6MLM,2018-09-27,3.5,
+6MYY,2018-11-02,3.8,
+6MZJ,2018-11-05,4.8,
+6N5B,2018-11-21,3.5,
+6N5D,2018-11-21,3.0,
+6N5E,2018-11-21,3.0,
+6N6B,2018-11-26,2.3,
+6N7J,2018-11-27,3.684,
+6NF5,2018-12-18,3.71,
+6NI2,2018-12-26,4.0,
+6NI3,2018-12-26,3.8,
+6NIP,2018-12-31,4.16,
+6NIU,2018-12-31,4.303,
+6NJL,2019-01-03,6.7,
+6NJM,2019-01-03,6.5,
+6NQD,2019-01-21,3.9,
+6NYP,2019-02-11,2.7,
+6O7H,2019-03-07,2.9,
+6OE4,2019-03-27,3.3,
+6OE5,2019-03-27,4.1,
+6OKP,2019-04-14,3.28,
+6OLP,2019-04-16,4.2,
+6OPN,2019-04-25,3.5,
+6OPO,2019-04-25,3.5,
+6OPP,2019-04-25,3.7,
+6OPQ,2019-04-25,3.8,
+6ORN,2019-04-30,4.05,
+6ORO,2019-04-30,3.9,
+6ORP,2019-04-30,4.4,
+6ORQ,2019-04-30,4.4,
+6OTC,2019-05-02,1.7,
+6OUS,2019-05-05,3.4,
+6OYA,2019-05-14,3.3,
+6OZ9,2019-05-15,3.462,
+6P3S,2019-05-24,4.0,
+6P59,2019-05-29,2.94221405643,
+6P62,2019-05-31,3.57,
+6P65,2019-05-31,3.94,
+6P91,2019-06-09,4.0,
+6P95,2019-06-09,3.5,
+6PA0,2019-06-11,2.05,
+6PCI,2019-06-17,4.12,
+6PCU,2019-06-18,2.4,
+6PW6,2019-07-22,4.5,
+6PXH,2019-07-26,2.3,
+6PZ8,2019-07-31,4.19,
+6PZW,2019-08-01,3.0,
+6PZY,2019-08-01,3.17,
+6PZZ,2019-08-01,3.6,
+6TYS,2019-08-09,3.5,
+6U02,2019-08-13,3.05,
+6U1N,2019-08-16,4.0,
+6U59,2019-08-27,3.86,
+6UBI,2019-09-11,1.903,
+6UCE,2019-09-16,1.382,
+6UCF,2019-09-16,1.29,
+6UDA,2019-09-19,4.2,
+6UDJ,2019-09-19,2.5,
+6UDK,2019-09-19,3.9,
+6UJB,2019-10-02,3.51,
+6UJC,2019-10-02,3.56,
+6ULC,2019-10-07,4.6,
+6UM5,2019-10-09,4.2,
+6UM6,2019-10-09,4.3,
+6UM7,2019-10-09,3.5,
+6UMG,2019-10-09,2.7,
+6UMX,2019-10-10,2.79,
+6UOE,2019-10-14,1.8,
+6UR5,2019-10-22,4.0,
+6URH,2019-10-23,2.2,
+6URM,2019-10-23,2.65,
+6USF,2019-10-26,3.87,
+6UTK,2019-10-29,3.8,
+6UVO,2019-11-03,2.9,
+6UYD,2019-11-13,1.897,
+6UYE,2019-11-13,3.96,
+6UYF,2019-11-13,2.06,
+6UYM,2019-11-13,2.848,
+6UYN,2019-11-13,2.85,
+6V4P,2019-11-28,2.8,
+6V6W,2019-12-06,6.5,
+6V8X,2019-12-12,3.0,
+6V8Z,2019-12-12,2.9,
+6VBO,2019-12-19,1.683,
+6VBP,2019-12-19,2.298,
+6VBQ,2019-12-19,2.116,
+6VEL,2020-01-02,2.65,
+6VJT,2020-01-17,1.782,
+6VKN,2020-01-21,3.7,
+6VLR,2020-01-24,4.42,
+6VLW,2020-01-27,3.42,
+6VN0,2020-01-29,4.25,
+6VN1,2020-01-29,2.8,
+6VPX,2020-02-04,5.0,
+6VTT,2020-02-13,3.7,
+6VY4,2020-02-25,2.0,
+6VY5,2020-02-25,3.4,
+6VY6,2020-02-25,2.6,
+6VYV,2020-02-27,6.33,
+6VZI,2020-02-28,2.716,
+6W03,2020-02-28,2.4,
+6W41,2020-03-09,3.084,
+6W4M,2020-03-11,3.2,
+6W4S,2020-03-11,3.2,
+6WAQ,2020-03-25,2.2,
+6WAR,2020-03-25,3.4,
+6WBV,2020-03-27,2.5,
+6WEX,2020-04-03,3.49,
+6WEZ,2020-04-03,3.21,
+6WF0,2020-04-03,3.46,
+6WF1,2020-04-03,4.19,
+6WHA,2020-04-07,3.36,
+6WHI,2020-04-08,4.2,
+6WHK,2020-04-08,2.6,
+6WIT,2020-04-10,2.79,
+6WIX,2020-04-10,2.67,
+6WO3,2020-04-24,2.382,
+6WO5,2020-04-24,2.619,
+6WOQ,2020-04-25,3.667,
+6WPS,2020-04-27,3.1,
+6WPT,2020-04-27,3.7,
+6WWC,2020-05-09,2.563,
+6WX2,2020-05-09,2.39,
+6X78,2020-05-29,2.359,
+6X7W,2020-05-30,1.7,
+6X96,2020-06-02,3.4,
+6X97,2020-06-02,3.65,
+6X98,2020-06-02,3.38,
+6X9R,2020-06-03,3.1,
+6X9S,2020-06-03,3.1,
+6X9T,2020-06-03,3.2,
+6X9U,2020-06-03,3.2,
+6X9V,2020-06-03,3.5,
+6X9X,2020-06-03,1.8,
+6XC2,2020-06-08,3.112,
+6XC3,2020-06-08,2.698,
+6XC4,2020-06-08,2.341,
+6XC7,2020-06-08,2.883,
+6XCJ,2020-06-08,2.8,
+6XCM,2020-06-08,3.42,
+6XCN,2020-06-08,3.66,
+6XDG,2020-06-10,3.9,
+6XE1,2020-06-11,2.75,
+6XEY,2020-06-14,3.25,
+6XKP,2020-06-26,2.72,
+6XKQ,2020-06-26,2.55,
+6XKR,2020-06-27,2.59,
+6XMI,2020-06-30,1.51,
+6XPQ,2020-07-08,4.2,
+6XPR,2020-07-08,4.092,
+6XPX,2020-07-09,2.598,
+6XPY,2020-07-09,3.603,
+6XPZ,2020-07-09,3.45,
+6XQ0,2020-07-09,2.3,
+6XQ2,2020-07-09,3.002,
+6XQ4,2020-07-09,3.347,
+6XRT,2020-07-13,3.9,
+6XSK,2020-07-15,3.85,
+6XSW,2020-07-16,2.98,
+6ZER,2020-06-16,3.8,
+7BEH,2020-12-23,2.3,
+7BEI,2020-12-23,2.3,
+7BEJ,2020-12-23,2.42,
+7BEK,2020-12-23,2.04,
+7BEL,2020-12-23,2.53,
+7BEM,2020-12-24,2.52,
+7BEN,2020-12-24,2.5,
+7BEO,2020-12-24,3.19,
+7BEP,2020-12-24,2.61,
+7BPK,2020-03-23,3.1,
+7BQ5,2020-03-24,2.99,
+7BSC,2020-03-30,2.31,
+7BSD,2020-03-30,2.53,
+7BZ5,2020-04-26,1.84,
+7C2L,2020-05-08,3.1,
+7CEB,2020-06-22,2.89,
+7CEC,2020-06-22,3.9,
+7CH4,2020-07-05,3.15,
+7CH5,2020-07-05,2.7,
+7CHB,2020-07-05,2.4,
+7CHC,2020-07-05,2.71,
+7CHE,2020-07-05,3.416,
+7CHF,2020-07-05,2.674,
+7CHH,2020-07-05,3.49,
+7CN2,2020-07-29,3.43,
+7CR5,2020-08-12,2.08,
+7D0B,2020-09-09,3.9,
+7D0C,2020-09-09,3.4,
+7D0D,2020-09-09,3.8,
+7D6I,2020-09-30,3.41,
+7DJZ,2020-11-22,2.397,
+7DK0,2020-11-22,3.199,
+7DK2,2020-11-22,3.0,
+7DM1,2020-12-01,2.1,
+7DM2,2020-12-01,2.4,
+7DNH,2020-12-09,3.64,
+7DNK,2020-12-09,6.41,
+7DNL,2020-12-09,4.19,
+7DPM,2020-12-20,3.304,
+7E39,2021-02-08,3.7,
+7E3B,2021-02-08,4.2,
+7E3C,2021-02-08,4.2,
+7E5R,2021-02-20,3.6,
+7E5S,2021-02-20,3.6,
+7E86,2021-03-01,2.9,
+7E88,2021-03-01,3.14,
+7E8M,2021-03-02,2.09,
+7E9N,2021-03-04,3.69,
+7E9O,2021-03-04,3.41,
+7E9P,2021-03-04,3.69,
+7E9Q,2021-03-04,3.65,
+7EAM,2021-03-07,1.4,
+7ECW,2021-03-13,3.1,
+7EJY,2021-04-03,3.04,
+7EJZ,2021-04-03,3.63,
+7EK0,2021-04-03,2.7,
+7ELN,2021-04-12,3.0,
+7EQG,2021-05-01,3.2,
+7EUO,2021-05-18,2.9,
+7F3Q,2021-06-16,3.3,
+7F6Y,2021-06-26,3.0,
+7F6Z,2021-06-26,3.0,
+7F7H,2021-06-29,3.19,
+7FAE,2021-07-06,3.65,
+7FAF,2021-07-06,3.69,
+7FAH,2021-07-06,3.151,
+7FBJ,2021-07-11,2.85,
+7FBK,2021-07-11,1.9,
+7FCI,2021-07-14,3.3,
+7FJN,2021-08-04,3.25,
+7FJO,2021-08-04,3.34,
+7FJS,2021-08-04,2.9,
+7JIX,2020-07-23,3.901,
+7JKT,2020-07-28,2.75,
+7JL0,2020-07-29,4.3,
+7JL2,2020-07-29,4.3,
+7JMP,2020-08-02,1.712,
+7JMW,2020-08-03,2.89,
+7JN5,2020-08-03,2.705,
+7JTF,2020-08-17,3.35,
+7JTG,2020-08-17,2.6,
+7JTI,2020-08-17,7.4,
+7JV2,2020-08-20,3.5,
+7JV4,2020-08-20,3.4,
+7JV6,2020-08-20,3.0,
+7JVA,2020-08-20,3.6,
+7JVC,2020-08-20,3.3,
+7JW0,2020-08-24,4.3,
+7JWB,2020-08-25,3.2,
+7JX3,2020-08-26,2.65,
+7K43,2020-09-14,2.6,
+7K45,2020-09-14,3.7,
+7K4N,2020-09-15,3.3,
+7K66,2020-09-18,3.92,
+7K8M,2020-09-27,3.2,
+7K8S,2020-09-27,3.4,
+7K8T,2020-09-27,3.4,
+7K8U,2020-09-27,3.8,
+7K8V,2020-09-27,3.8,
+7K8W,2020-09-27,3.6,
+7K8X,2020-09-27,3.9,
+7K8Y,2020-09-27,4.4,
+7K8Z,2020-09-27,3.5,
+7K90,2020-09-27,3.24,
+7K9H,2020-09-29,3.2,
+7K9I,2020-09-29,3.3,
+7K9J,2020-09-29,3.0,
+7K9K,2020-09-29,3.14,
+7KBA,2020-10-01,2.8,
+7KBB,2020-10-01,4.02,
+7KBT,2020-10-02,4.15,
+7KDD,2020-10-08,3.5,
+7KDE,2020-10-08,3.55,
+7KEJ,2020-10-11,3.8,
+7KEW,2020-10-13,4.16,
+7KEX,2020-10-13,4.25,
+7KF9,2020-10-13,4.4,
+7KFB,2020-10-13,3.9,
+7KFE,2020-10-13,6.6,
+7KFH,2020-10-13,3.8,
+7KFV,2020-10-15,2.102,
+7KFW,2020-10-15,2.792,
+7KFX,2020-10-15,2.226,
+7KFY,2020-10-15,2.157,
+7KI4,2020-10-23,2.9,
+7KI6,2020-10-23,2.8,
+7KKH,2020-10-27,2.0,
+7KKK,2020-10-27,3.03,
+7KKL,2020-10-27,2.85,
+7KLC,2020-10-29,4.3,
+7KLG,2020-10-30,3.2,
+7KLH,2020-10-30,3.0,
+7KM5,2020-11-02,3.19,
+7KMD,2020-11-02,3.39228580771,
+7KMG,2020-11-02,2.16,
+7KMH,2020-11-02,1.72,
+7KMI,2020-11-02,1.73,
+7KMK,2020-11-03,4.2,
+7KML,2020-11-03,3.8,
+7KN3,2020-11-04,2.251,
+7KN4,2020-11-04,2.7,
+7KN5,2020-11-04,1.87,
+7KN6,2020-11-04,2.55,
+7KN7,2020-11-04,2.73,
+7KQ7,2020-11-13,2.203,
+7KQB,2020-11-14,2.42,
+7KQE,2020-11-15,2.88,
+7KQG,2020-11-16,2.6,
+7KQH,2020-11-16,3.5,
+7KQI,2020-11-16,4.2,
+7KR5,2020-11-18,3.3,
+7KRA,2020-11-19,3.2,
+7KS9,2020-11-21,4.75,
+7KSG,2020-11-22,3.33,
+7KTX,2020-11-24,4.3,
+7KXJ,2020-12-04,6.4,
+7KXK,2020-12-04,5.0,
+7KYL,2020-12-08,2.0,
+7KYO,2020-12-08,2.85,
+7KZB,2020-12-10,2.83,
+7L02,2020-12-10,3.2,
+7L06,2020-12-11,3.3,
+7L09,2020-12-11,3.1,
+7L0L,2020-12-11,2.85,
+7L2C,2020-12-16,3.65,
+7L2D,2020-12-16,3.55,
+7L2E,2020-12-16,2.97,
+7L2F,2020-12-16,3.9,
+7L3N,2020-12-18,3.27,
+7L56,2020-12-21,3.6,
+7L57,2020-12-21,5.87,
+7L58,2020-12-21,5.07,
+7L5B,2020-12-21,3.18,
+7L5J,2020-12-22,3.2,
+7L7D,2020-12-28,2.5,
+7L7E,2020-12-28,3.0,
+7L86,2020-12-31,3.4,
+7L87,2020-12-31,3.6,
+7L88,2020-12-31,3.6,
+7L89,2020-12-31,3.8,
+7L8A,2020-12-31,3.3,
+7L8B,2020-12-31,3.7,
+7L8C,2020-12-31,3.4,
+7L8D,2020-12-31,4.6,
+7L8S,2020-12-31,4.3,
+7L8T,2020-12-31,3.7,
+7L8U,2021-01-01,4.5,
+7L8W,2021-01-01,4.1,
+7L8X,2021-01-01,3.0,
+7L8Y,2021-01-01,4.2,
+7L8Z,2021-01-01,3.8,
+7L90,2021-01-01,4.5,
+7LAA,2021-01-06,3.42,
+7LAB,2021-01-06,2.97,
+7LBE,2021-01-07,2.9,
+7LBF,2021-01-07,2.8,
+7LBG,2021-01-07,2.6,
+7LDD,2021-01-13,3.4,
+7LDJ,2021-01-13,2.36,
+7LFZ,2021-01-19,1.9,
+7LG0,2021-01-19,2.3,
+7LG2,2021-01-19,2.4,
+7LG3,2021-01-19,2.3,
+7LG6,2021-01-19,3.28,
+7LJ4,2021-01-28,2.782,
+7LJ5,2021-01-28,2.26,
+7LJA,2021-01-28,2.77,
+7LJB,2021-01-28,2.97,
+7LJR,2021-01-30,3.66,
+7LL1,2021-02-03,3.73,
+7LL2,2021-02-03,3.73,
+7LLK,2021-02-04,4.8,
+7LM8,2021-02-05,1.936,
+7LM9,2021-02-05,1.53,
+7LO6,2021-02-09,3.9,
+7LOK,2021-02-10,3.9,
+7LOP,2021-02-10,2.246,
+7LQV,2021-02-15,3.25,
+7LQW,2021-02-15,4.47,
+7LR3,2021-02-15,2.8,
+7LR4,2021-02-15,2.1,
+7LRS,2021-02-17,3.89,
+7LRT,2021-02-17,3.54,
+7LS9,2021-02-17,3.42,
+7LSB,2021-02-18,2.492,
+7LSE,2021-02-18,2.35,
+7LSF,2021-02-18,2.24,
+7LSG,2021-02-18,1.86,
+7LSI,2021-02-18,2.4,
+7LSS,2021-02-18,3.72,
+7LU9,2021-02-21,5.6,
+7LUA,2021-02-21,4.7,
+7LUC,2021-02-22,3.21,
+7LUE,2021-02-22,2.9,
+7LVW,2021-02-26,2.1,
+7LWD,2021-03-01,3.65,
+7LX2,2021-03-03,3.12,
+7LX3,2021-03-03,3.45,
+7LXM,2021-03-04,3.41,
+7LXN,2021-03-04,3.85,
+7LXW,2021-03-05,2.8,
+7LXX,2021-03-05,3.0,
+7LXY,2021-03-05,2.2,
+7LXZ,2021-03-05,2.6,
+7LY0,2021-03-05,2.6,
+7LY2,2021-03-05,2.5,
+7LY3,2021-03-05,3.0,
+7LY9,2021-03-06,3.91,
+7M2H,2021-03-16,2.642,
+7M2I,2021-03-16,2.695,
+7M2J,2021-03-16,3.201,
+7M30,2021-03-17,3.81,
+7M3I,2021-03-18,2.8,
+7M42,2021-03-19,3.3,
+7M51,2021-03-22,1.8,
+7M52,2021-03-22,1.5,
+7M53,2021-03-22,1.4,
+7M55,2021-03-22,1.4,
+7M7E,2021-03-28,3.2,
+7M7F,2021-03-28,3.2,
+7M7G,2021-03-28,4.1,
+7M7H,2021-03-28,4.1,
+7M7I,2021-03-28,3.4,
+7M7J,2021-03-28,4.3,
+7M7W,2021-03-29,2.65,
+7M8J,2021-03-29,3.48,
+7M8L,2021-03-30,3.9,
+7MDW,2021-04-06,3.58,
+7ME7,2021-04-06,3.73,
+7MEJ,2021-04-06,3.55,
+7MEM,2021-04-06,3.2,
+7MF1,2021-04-08,2.092,
+7MFG,2021-04-09,3.87,
+7MGX,2021-04-13,3.13,
+7MH6,2021-04-14,2.85,
+7MJI,2021-04-20,2.81,
+7MJJ,2021-04-20,3.32,
+7MJK,2021-04-20,2.73,
+7MJL,2021-04-20,2.95,
+7MJS,2021-04-20,3.03,
+7MK2,2021-04-21,3.8,
+7MK3,2021-04-21,3.06,
+7MKB,2021-04-22,1.9,
+7MKL,2021-04-24,3.2,
+7MKM,2021-04-24,3.16,
+7MLZ,2021-04-29,3.71,
+7MM0,2021-04-29,3.15,
+7MMN,2021-04-29,3.57,
+7MMO,2021-04-30,2.427,
+7MN8,2021-04-30,3.45,
+7MNM,2021-05-01,4.7,
+7MNN,2021-05-01,6.7,
+7MRZ,2021-05-10,3.0,
+7MW2,2021-05-15,2.97,
+7MW3,2021-05-15,3.15,
+7MW4,2021-05-15,3.42,
+7MW5,2021-05-15,3.42,
+7MW6,2021-05-15,3.22,
+7MWW,2021-05-17,2.71,
+7MWX,2021-05-17,3.32,
+7MXD,2021-05-19,3.4,
+7MXP,2021-05-19,4.46,
+7MY2,2021-05-20,2.65,
+7MY3,2021-05-20,2.9,
+7N0I,2021-05-25,2.2,
+7N0R,2021-05-25,1.42,
+7N28,2021-05-28,4.2,
+7N3I,2021-06-01,2.03,
+7N4I,2021-06-04,2.284,
+7N4J,2021-06-04,2.207,
+7N4L,2021-06-04,3.601,
+7N4M,2021-06-04,3.79,
+7N5H,2021-06-05,3.24,
+7N62,2021-06-07,4.0,
+7N64,2021-06-07,4.2,
+7N65,2021-06-07,4.15,
+7N6D,2021-06-08,2.3,
+7N6E,2021-06-08,3.2,
+7N8H,2021-06-14,2.3,
+7N8I,2021-06-14,3.0,
+7N9A,2021-06-17,3.5,
+7N9B,2021-06-17,3.8,
+7N9C,2021-06-17,3.71,
+7N9E,2021-06-17,3.52,
+7N9U,2021-06-18,3.19,
+7N9V,2021-06-18,3.45,
+7N9X,2021-06-18,3.511,
+7NAB,2021-06-21,2.15,
+7ND3,2021-01-30,3.7,
+7ND4,2021-01-30,3.6,
+7ND5,2021-01-30,3.4,
+7ND6,2021-01-30,7.3,
+7ND7,2021-01-30,3.6,
+7ND8,2021-01-30,3.5,
+7ND9,2021-01-30,2.8,
+7NDB,2021-01-30,4.6,
+7NDC,2021-01-30,4.1,
+7NDD,2021-01-30,4.2,
+7NEG,2021-02-04,2.19,
+7NEH,2021-02-04,1.77,
+7NX6,2021-03-17,2.25,
+7NX7,2021-03-17,2.3,
+7NX8,2021-03-17,1.95,
+7NX9,2021-03-17,2.4,
+7NXA,2021-03-17,2.5,
+7NXB,2021-03-17,2.67,
+7Q6E,2021-11-07,2.7,
+7Q9F,2021-11-12,3.6,
+7Q9G,2021-11-12,3.3,
+7Q9I,2021-11-12,4.9,
+7Q9J,2021-11-12,4.0,
+7Q9K,2021-11-12,4.5,
+7Q9M,2021-11-12,3.7,
+7Q9P,2021-11-12,4.5,
+7R6W,2021-06-23,1.83,
+7R6X,2021-06-23,2.95,
+7R7N,2021-06-25,3.95,
+7R7V,2021-06-25,1.6,
+7R7W,2021-06-25,1.17,
+7R7X,2021-06-25,2.099,
+7R7Y,2021-06-25,1.601,
+7R80,2021-06-25,2.9,
+7R87,2021-06-26,3.4,
+7R88,2021-06-26,3.5,
+7R8L,2021-06-26,2.6,
+7R8M,2021-06-26,3.4,
+7R8N,2021-06-26,3.55,
+7R8O,2021-06-26,3.5,
+7R8U,2021-06-27,1.901,
+7R98,2021-06-28,2.51,
+7RA8,2021-06-30,3.1,
+7RAL,2021-07-01,,
+7RBU,2021-07-06,3.7,
+7RBV,2021-07-06,3.6,
+7RFB,2021-07-14,2.7,
+7RFC,2021-07-14,3.24,
+7RKS,2021-07-22,2.7,
+7RKU,2021-07-22,3.2,
+7RKV,2021-07-22,3.45,
+7RNJ,2021-07-29,2.67,
+7RQ6,2021-08-05,4.18,
+7RR0,2021-08-08,3.12,
+7RSN,2021-08-11,3.49,
+7RSO,2021-08-11,4.1,
+7RU3,2021-08-16,3.3,
+7RU4,2021-08-16,3.3,
+7RU5,2021-08-16,3.6,
+7RU8,2021-08-16,3.8,
+7RW2,2021-08-19,3.5,
+7S07,2021-08-30,3.29,
+7S0B,2021-08-30,2.9,
+7S0C,2021-08-30,3.25,
+7S0D,2021-08-30,3.5,
+7S0E,2021-08-30,4.9,
+7S3M,2021-09-07,2.4,
+7S3N,2021-09-07,1.9,
+7S4S,2021-09-09,2.05,
+7S4U,2021-09-09,3.56,
+7S4V,2021-09-09,3.28,
+7S4X,2021-09-09,2.76,
+7S5P,2021-09-11,2.86,
+7S5Q,2021-09-11,2.88,
+7S5R,2021-09-11,2.45,
+7S6I,2021-09-14,3.2,
+7S6J,2021-09-14,3.4,
+7S6K,2021-09-14,3.4,
+7S6L,2021-09-14,4.0,
+7S83,2021-09-17,2.52,
+7S8G,2021-09-17,2.57,
+7S8H,2021-09-17,2.7,
+7SB3,2021-09-23,3.3,
+7SB4,2021-09-23,4.7,
+7SB5,2021-09-23,4.2,
+7SBV,2021-09-26,3.1,
+7SBW,2021-09-26,3.2,
+7SBX,2021-09-26,3.0,
+7SBY,2021-09-26,3.0,
+7SC1,2021-09-26,3.2,
+7SCN,2021-09-28,3.02,
+7SCO,2021-09-28,3.37,
+7SD3,2021-09-29,3.67,
+7SD5,2021-09-29,1.53,
+7SEM,2021-09-30,2.2,
+7SGF,2021-10-05,4.41,
+7SH0,2021-10-07,3.2,
+7SI2,2021-10-12,3.2,
+7SJ0,2021-10-15,3.36,
+7SK3,2021-10-19,3.8,
+7SK4,2021-10-19,3.3,
+7SK5,2021-10-19,4.0,
+7SK7,2021-10-19,3.3,
+7SK8,2021-10-19,3.3,
+7SK9,2021-10-19,3.7,
+7SKZ,2021-10-22,1.86,
+7SL5,2021-10-22,2.5,
+7SN3,2021-10-27,3.1,
+7SO9,2021-10-29,2.4,
+7SOA,2021-10-29,3.1,
+7SOB,2021-10-29,2.4,
+7SOC,2021-10-29,3.3,
+7SOD,2021-10-29,3.2,
+7SOE,2021-10-29,2.8,
+7SOF,2021-10-29,3.6,
+7SPO,2021-11-02,1.92,
+7SPP,2021-11-02,1.96,
+7SQ1,2021-11-04,3.8,
+7SSC,2021-11-10,1.8,
+7SSU,2021-11-11,3.22,
+7ST3,2021-11-11,2.78,
+7STG,2021-11-12,2.7,
+7STR,2021-11-15,1.5,
+7STS,2021-11-15,2.16,
+7STZ,2021-11-15,2.95,
+7SWD,2021-11-19,3.59,
+7SWN,2021-11-20,4.3,
+7SWO,2021-11-20,4.1,
+7SWP,2021-11-20,3.8,
+7SWW,2021-11-21,3.13,
+7SWX,2021-11-21,3.13,
+7SX6,2021-11-22,3.4,
+7SX7,2021-11-22,2.15,
+7SYY,2021-11-25,2.74,
+7SYZ,2021-11-25,2.86,
+7T0W,2021-11-30,3.0,
+7T0Z,2021-11-30,3.0,
+7T2P,2021-12-06,3.47,
+7T3D,2021-12-07,3.38,
+7T3M,2021-12-08,3.0,
+7T4G,2021-12-09,3.7,
+7T4Q,2021-12-10,2.9,
+7T4R,2021-12-10,3.3,
+7T4S,2021-12-10,3.1,
+7T5O,2021-12-12,3.39,
+7T67,2021-12-13,3.0,
+7T6B,2021-12-13,3.19,
+7T6X,2021-12-14,3.83,
+7T73,2021-12-14,4.0,
+7T74,2021-12-14,3.35,
+7T75,2021-12-14,2.7,
+7T76,2021-12-14,4.43,
+7T77,2021-12-14,4.75,
+7T7B,2021-12-14,2.59,
+7T8W,2021-12-17,3.1,
+7T9A,2021-12-18,3.54,
+7T9B,2021-12-18,3.72,
+7T9T,2021-12-20,3.7,
+7TAS,2021-12-21,3.2,
+7TAT,2021-12-21,3.2,
+7TB8,2021-12-21,2.83,
+7TBF,2021-12-21,3.1,
+7TC9,2021-12-23,5.08,
+7TCA,2021-12-23,3.85,
+7TCC,2021-12-23,3.86,
+7TCQ,2021-12-28,2.02,
+7TE1,2022-01-03,3.5,
+7TE6,2022-01-04,4.55,
+7TE9,2022-01-04,3.92,
+7TEB,2022-01-04,4.23,
+7TEE,2022-01-04,6.59,
+7TEQ,2022-01-05,7.51,
+7TER,2022-01-05,5.23,
+7TES,2022-01-05,4.7,
+7TET,2022-01-05,4.45,
+7TFN,2022-01-06,4.0,
+7TFO,2022-01-06,4.1,
+7THE,2022-01-10,3.87,
+7THT,2022-01-12,3.42,
+7TJQ,2022-01-16,3.13,
+7TL0,2022-01-17,3.06,
+7TN0,2022-01-20,2.85,
+7TN9,2022-01-20,3.1,
+7TOW,2022-01-24,2.15,
+7TP4,2022-01-24,1.95,
+7TPR,2022-01-25,2.39,
+7TQG,2022-01-26,2.07,
+7TRH,2022-01-28,3.0,
+7TRI,2022-01-28,3.6,
+7TRK,2022-01-29,2.8,
+7TRP,2022-01-30,2.4,
+7TRQ,2022-01-30,2.5,
+7TRS,2022-01-30,2.8,
+7TTM,2022-02-01,2.24,
+7TTX,2022-02-02,2.8,
+7TTY,2022-02-02,3.11,
+7TVJ,2022-02-05,2.39,
+7TYV,2022-02-14,2.8,
+7TZ5,2022-02-15,3.41,
+7U09,2022-02-17,2.1,
+7U0A,2022-02-17,1.7,
+7U0B,2022-02-17,2.79,
+7U0C,2022-02-17,3.3,
+7U0D,2022-02-17,4.8,
+7U0E,2022-02-18,2.1,
+7U0L,2022-02-18,3.3,
+7U0Q,2022-02-18,3.86,
+7U0X,2022-02-19,3.82,
+7U2D,2022-02-23,2.76,
+7U2E,2022-02-23,2.85,
+7U8E,2022-03-08,2.29,
+7U8J,2022-03-08,4.9,
+7U8L,2022-03-08,4.56,
+7U8M,2022-03-08,5.39,
+7U9G,2022-03-10,3.39,
+7U9O,2022-03-11,3.4,
+7U9P,2022-03-11,3.5,
+7UCE,2022-03-16,2.25,
+7UCF,2022-03-16,4.0,
+7UCG,2022-03-16,3.5,
+7UDS,2022-03-20,3.1,
+7UGN,2022-03-25,3.4,
+7UGO,2022-03-25,4.1,
+7UGP,2022-03-25,4.2,
+7UGQ,2022-03-25,3.4,
+7UI0,2022-03-28,3.4,
+7UJD,2022-03-30,2.5,
+7UKL,2022-04-01,3.09,
+7UKM,2022-04-01,3.03,
+7UL0,2022-04-03,2.49,
+7UL1,2022-04-03,2.65,
+7UL7,2022-04-04,3.59,
+7UOJ,2022-04-13,4.02,
+7UOP,2022-04-13,2.8,
+7UOT,2022-04-13,2.77,
+7UOV,2022-04-14,2.75,
+7UP9,2022-04-14,2.9,
+7UPA,2022-04-14,2.5,
+7UPB,2022-04-14,3.0,
+7UPD,2022-04-14,2.4,
+7UPK,2022-04-15,2.8,
+7UPM,2022-04-15,2.7,
+7UR4,2022-04-21,3.34,
+7UR6,2022-04-21,3.46,
+7URQ,2022-04-22,2.05,
+7URS,2022-04-22,2.4,
+7UST,2022-04-25,1.7,
+7USV,2022-04-25,2.1,
+7UVH,2022-05-02,2.59,
+7UVI,2022-05-02,2.92,
+7UVO,2022-05-02,2.09,
+7UVQ,2022-05-02,3.29,
+7UVS,2022-05-02,2.06,
+7UYL,2022-05-06,2.0,
+7UYM,2022-05-06,2.2,
+7UZ4,2022-05-08,3.1,
+7UZ5,2022-05-08,3.2,
+7UZ6,2022-05-08,2.8,
+7UZ7,2022-05-08,2.9,
+7UZ8,2022-05-08,3.1,
+7UZ9,2022-05-08,3.5,
+7UZA,2022-05-08,3.1,
+7UZB,2022-05-08,4.1,
+7UZC,2022-05-08,2.2,
+7UZD,2022-05-08,3.0,
+7VFA,2021-09-11,1.75,
+7VFB,2021-09-11,2.0,
+7VGR,2021-09-18,2.7,
+7VGS,2021-09-18,2.8,
+7VN9,2021-10-10,4.49,
+7VNG,2021-10-11,3.8,
+7VQ0,2021-10-18,3.03,
+7VYR,2021-11-15,2.2,
+7VZT,2021-11-16,3.41,
+7W1S,2021-11-20,1.997,
+7WBZ,2021-12-17,2.42,
+7WCD,2021-12-19,3.3,
+7WE7,2021-12-23,3.8,
+7WE8,2021-12-23,3.5,
+7WE9,2021-12-23,3.6,
+7WEA,2021-12-23,3.3,
+7WEB,2021-12-23,3.7,
+7WEC,2021-12-23,3.3,
+7WED,2021-12-23,3.5,
+7WEE,2021-12-23,4.0,
+7WEF,2021-12-23,3.8,
+7WH8,2021-12-30,3.11,
+7WHB,2021-12-30,2.67,
+7WHD,2021-12-30,2.65,
+7WJ5,2022-01-05,3.72,
+7WLC,2022-01-13,4.0,
+7WLY,2022-01-14,3.4,
+7WLZ,2022-01-14,2.98,
+7WM0,2022-01-14,3.35,
+7WN2,2022-01-17,2.35,
+7WNB,2022-01-18,2.18,
+7WON,2022-01-22,3.9,
+7WP0,2022-01-22,3.71,
+7WP1,2022-01-22,3.77,
+7WP2,2022-01-22,3.52,
+7WP5,2022-01-22,3.9,
+7WP6,2022-01-23,3.81,
+7WP8,2022-01-23,3.88,
+7WPH,2022-01-23,2.89,
+7WRO,2022-01-27,3.4,
+7WS0,2022-01-28,3.2,
+7WS1,2022-01-28,3.4,
+7WS2,2022-01-28,3.3,
+7WS3,2022-01-28,3.6,
+7WS4,2022-01-28,3.7,
+7WS5,2022-01-28,3.7,
+7WS6,2022-01-28,3.8,
+7WS7,2022-01-28,3.4,
+7WT7,2022-02-04,3.4,
+7WT8,2022-02-04,3.6,
+7WT9,2022-02-04,4.3,
+7WTF,2022-02-04,3.0,
+7WTG,2022-02-04,3.8,
+7WTH,2022-02-04,4.3,
+7WTI,2022-02-04,3.8,
+7WTJ,2022-02-04,4.2,
+7WTK,2022-02-04,3.6,
+7WUE,2022-02-08,3.2,
+7WUH,2022-02-08,4.7,
+7WUR,2022-02-09,3.5,
+7WVL,2022-02-10,3.0,
+7WVM,2022-02-10,3.4,
+7WWI,2022-02-13,3.5,
+7WWJ,2022-02-13,3.5,
+7WWK,2022-02-13,3.4,
+7X08,2022-02-21,2.7,
+7X1M,2022-02-24,2.74,
+7X26,2022-02-25,3.685,
+7X27,2022-02-25,2.49,
+7X2H,2022-02-25,2.1,
+7X2J,2022-02-25,2.4,
+7X2K,2022-02-25,2.4,
+7X2L,2022-02-25,2.4,
+7X2M,2022-02-25,1.8,
+7X63,2022-03-06,2.24,
+7X66,2022-03-06,2.4,
+7X6A,2022-03-07,3.5,
+7X7D,2022-03-09,2.92,
+7X7E,2022-03-09,2.67,
+7X7T,2022-03-10,3.48,
+7X7U,2022-03-10,3.77,
+7X7V,2022-03-10,3.83,
+7X9E,2022-03-15,2.6,
+7XD2,2022-03-26,3.3,
+7XEG,2022-03-31,2.69,
+7XEI,2022-03-31,2.76,
+7XH8,2022-04-07,2.99,
+7XIC,2022-04-12,3.3,
+7XIK,2022-04-13,2.89,
+7XIL,2022-04-13,2.91,
+7XJ6,2022-04-15,3.29,
+7XJ8,2022-04-15,3.3,
+7XJ9,2022-04-15,3.27,
+7XNO,2022-04-29,2.54,
+7XOD,2022-05-01,3.27,
+7XRP,2022-05-11,3.88,
+7XS8,2022-05-13,2.8,
+7XSA,2022-05-13,2.2,
+7XSB,2022-05-13,3.2,
+7XSC,2022-05-13,2.88,
+7XSW,2022-05-15,3.3,
+7XXL,2022-05-30,7.3,
+7XY3,2022-05-31,4.6,
+7XY4,2022-05-31,3.3,
+7Y0C,2022-06-04,2.94,
+7Y0N,2022-06-05,3.8,
+7Y0O,2022-06-05,4.4,
+7Y0V,2022-06-06,2.48,
+7Y3N,2022-06-11,2.97,
+7Y3O,2022-06-11,2.1,
+7Y58,2022-06-16,3.8,
+7Y6K,2022-06-20,3.34,
+7Y7J,2022-06-22,3.8,
+7Y7K,2022-06-22,4.4,
+7Y8J,2022-06-24,1.03,
+7YAD,2022-06-27,2.66,
+7YC5,2022-06-30,3.1,
+7YCK,2022-07-01,2.6,
+7YCL,2022-07-01,2.13,
+7YCN,2022-07-01,2.85,
+7YDI,2022-07-04,3.98,
+7YDY,2022-07-04,4.75,
+7YE5,2022-07-05,6.75,
+7YE9,2022-07-05,4.17,
+7YEG,2022-07-05,3.73,
+7YH6,2022-07-12,3.4,
+7YH7,2022-07-13,3.3,
+7YHK,2022-07-13,3.14,
+7YHS,2022-07-14,3.37,
+7YI6,2022-07-15,2.28,
+7YK4,2022-07-21,2.7,
+7YKJ,2022-07-22,3.5,
+7YLB,2022-07-26,2.41,
+7YLD,2022-07-26,2.8,
+7YOW,2022-08-02,3.3,
+7YRN,2022-08-10,2.99,
+7Z0Y,2022-02-23,2.95,
+8CSJ,2022-05-12,3.53,
+8CT6,2022-05-13,3.1,
+8CW9,2022-05-18,3.46,
+8CZ5,2022-05-24,2.645,
+8D01,2022-05-25,2.46,
+8D0Y,2022-05-26,4.7,
+8D0Z,2022-05-26,3.7,
+8D21,2022-05-27,3.96,
+8D4R,2022-06-02,3.81,
+8D50,2022-06-03,4.32,
+8D53,2022-06-03,3.24,
+8D5C,2022-06-04,3.9,
+8D8Q,2022-06-08,4.2,
+8D8R,2022-06-08,4.1,
+8D9Y,2022-06-12,2.2,
+8D9Z,2022-06-12,1.8,
+8DA0,2022-06-12,2.2,
+8DA1,2022-06-12,2.67,
+8DAD,2022-06-13,3.85,
+8DAM,2022-06-13,2.0,
+8DBZ,2022-06-15,4.1,
+8DCC,2022-06-16,2.6,
+8DCE,2022-06-16,2.0,
+8DD2,2022-06-17,2.9,
+8DD3,2022-06-17,2.9,
+8DFG,2022-06-22,2.0,
+8DFH,2022-06-22,2.3,
+8DFI,2022-06-22,1.9,
+8DI5,2022-06-28,3.04,
+8DIM,2022-06-29,2.62,
+8DIS,2022-06-29,2.62,
+8DIU,2022-06-29,2.61,
+8DJG,2022-06-30,2.65,
+8DLY,2022-07-08,3.0,
+8DLZ,2022-07-08,2.57,
+8DM0,2022-07-08,3.21,
+8DM3,2022-07-08,2.37,
+8DM4,2022-07-08,2.45,
+8DMH,2022-07-08,3.19,
+8DMJ,2022-07-08,3.2,
+8DN7,2022-07-10,2.0,
+8DNN,2022-07-11,3.12,
+8DOK,2022-07-13,3.2,
+8DOW,2022-07-14,3.69,
+8DP1,2022-07-14,3.46,
+8DPL,2022-07-15,2.53,
+8DPM,2022-07-15,3.0,
+8DPZ,2022-07-18,3.38,
+8DT3,2022-07-25,3.3,
+8DTK,2022-07-25,3.77,
+8DTO,2022-07-26,3.57,
+8DUA,2022-07-27,4.32,
+8DVD,2022-07-28,4.12,
+8DW2,2022-07-30,4.11,
+8DW3,2022-07-30,4.26,
+8DW9,2022-08-01,4.0,
+8DWA,2022-08-01,3.2,
+8DWW,2022-08-02,3.13,
+8DWX,2022-08-02,3.27,
+8DWY,2022-08-02,3.18,
+8DXS,2022-08-03,3.76,
+8DY6,2022-08-03,4.32,
+8DZH,2022-08-07,3.2,
+8DZI,2022-08-07,3.5,
+8E0E,2022-08-09,2.0,
+8E1P,2022-08-11,3.82,
+8E99,2022-08-26,4.24,
+8EE5,2022-09-06,3.583,
+8EE8,2022-09-06,2.803,
+8EED,2022-09-07,3.487,
+8EEE,2022-09-07,2.819,
+8EJJ,2022-09-16,3.22,
+8EL2,2022-09-22,2.89,
+8ELG,2022-09-24,1.65,
+8ELH,2022-09-24,1.85,
+8ELJ,2022-09-24,3.6,
+8ELO,2022-09-26,2.72,
+8ELP,2022-09-26,2.83,
+8ELQ,2022-09-26,2.21,
+8EQ6,2022-10-07,1.65,
+8ERQ,2022-10-12,3.3,
+8ERR,2022-10-12,3.1,
+8EUU,2022-10-19,2.7,
+8EUV,2022-10-19,2.6,
+8EUW,2022-10-19,2.7,
+8EYG,2022-10-27,3.73,
+8EYH,2022-10-27,3.75,
+8F0G,2022-11-02,3.35,
+8F0H,2022-11-02,3.18,
+8F0I,2022-11-03,3.7,
+8F0J,2022-11-03,2.0,
+8F0K,2022-11-03,1.9,
+8F2A,2022-11-07,2.2,
+8F2B,2022-11-07,2.0,
+8F2J,2022-11-08,3.16,
+8F38,2022-11-09,2.64,
+8F4P,2022-11-11,3.7,
+8F6X,2022-11-17,3.25,
+8F92,2022-11-23,3.14,
+8F9G,2022-11-23,3.2,
+8F9M,2022-11-23,4.1,
+8FAH,2022-11-26,4.22,
+8FAX,2022-11-28,2.1,
+8FBW,2022-11-30,2.35,
+8FFE,2022-12-08,1.72,
+8FHY,2022-12-15,2.53,
+8FI9,2022-12-15,4.2,
+8FR6,2023-01-06,2.5,
+8FXB,2023-01-24,3.1,
+8FXC,2023-01-24,3.2,
+8FYI,2023-01-26,3.4,
+8FYJ,2023-01-26,4.0,
+8G30,2023-02-06,3.1,
+8G3M,2023-02-08,3.0,
+8G3N,2023-02-08,2.9,
+8G3O,2023-02-08,3.1,
+8G3P,2023-02-08,2.5,
+8G3Q,2023-02-08,2.3,
+8G3R,2023-02-08,2.3,
+8G3V,2023-02-08,2.2,
+8G3Z,2023-02-08,2.3,
+8G40,2023-02-08,2.8,
+8G4T,2023-02-10,2.81,
+8G6U,2023-02-16,3.16,
+8G70,2023-02-16,3.4,
+8G72,2023-02-16,5.6,
+8G73,2023-02-16,2.5,
+8G74,2023-02-16,2.5,
+8G75,2023-02-16,3.4,
+8G76,2023-02-16,3.8,
+8G77,2023-02-16,2.8,
+8G78,2023-02-16,3.4,
+8G79,2023-02-16,6.1,
+8G7A,2023-02-16,3.3,
+8G7B,2023-02-16,3.2,
+8G7C,2023-02-16,4.1,
+8GAS,2023-02-23,4.04,
+8GAT,2023-02-23,3.0,
+8GAU,2023-02-23,3.6,
+8GAV,2023-02-23,2.7,
+8GF2,2023-03-07,2.851,
+8GHK,2023-03-10,3.47,
+8GIO,2023-03-14,2.67,
+8GIR,2023-03-14,2.5,
+8GIS,2023-03-14,2.46,
+8GIT,2023-03-14,2.72,
+8GJE,2023-03-15,3.4,
+8GNG,2022-08-23,3.2,
+8GO8,2022-08-24,3.41,
+8GO9,2022-08-24,3.35,
+8GOC,2022-08-24,4.18,
+8GOM,2022-08-25,2.783,
+8GON,2022-08-25,2.601,
+8GS9,2022-09-05,2.66,
+8GSB,2022-09-05,3.99,
+8GSE,2022-09-06,3.7,
+8GTO,2022-09-08,3.2,
+8GTP,2022-09-08,3.1,
+8GTQ,2022-09-08,3.1,
+8GV5,2022-09-14,3.2,
+8GV6,2022-09-14,3.4,
+8GV7,2022-09-14,2.6,
+8GX9,2022-09-19,4.01,
+8GZ5,2022-09-25,1.7,
+8GZN,2022-09-27,3.6,
+8GZZ,2022-09-27,3.52,
+8H00,2022-09-27,3.41,
+8H01,2022-09-27,3.7,
+8H07,2022-09-28,2.9,
+8H08,2022-09-28,3.2,
+8H4I,2022-10-10,3.06,
+8H4K,2022-10-10,3.1,
+8H4L,2022-10-10,3.07,
+8H63,2022-10-15,1.53,
+8H64,2022-10-15,2.35,
+8H7L,2022-10-20,2.44,
+8H7Z,2022-10-21,3.07,
+8H91,2022-10-24,3.07,
+8HC2,2022-11-01,6.21,
+8HC3,2022-11-01,4.35,
+8HC4,2022-11-01,3.54,
+8HC5,2022-11-01,3.43,
+8HC6,2022-11-01,4.69,
+8HC7,2022-11-01,4.54,
+8HC8,2022-11-01,3.95,
+8HC9,2022-11-01,6.03,
+8HCA,2022-11-01,4.35,
+8HCB,2022-11-01,4.18,
+8HEB,2022-11-08,3.53,
+8HEC,2022-11-08,3.5,
+8HED,2022-11-08,3.59,
+8HES,2022-11-08,2.2,
+8HGL,2022-11-15,2.9,
+8HGM,2022-11-15,3.4,
+8HHX,2022-11-17,3.62,
+8HHY,2022-11-17,2.77,
+8HHZ,2022-11-17,4.28,
+8HLD,2022-11-29,2.8,
+8HN6,2022-12-07,2.07,
+8HN7,2022-12-07,3.0,
+8HP9,2022-12-12,2.75,
+8HPF,2022-12-12,2.34,
+8HPJ,2022-12-12,3.3,
+8HPK,2022-12-12,3.0,
+8HPQ,2022-12-12,2.85,
+8HPT,2022-12-13,3.39,
+8HPU,2022-12-13,2.56,
+8HPV,2022-12-13,2.65,
+8HQ7,2022-12-13,2.7,
+8HQC,2022-12-13,3.89,
+8HR2,2022-12-14,1.94,
+8HRD,2022-12-15,2.86,
+8HWS,2023-01-02,2.36,
+8HWT,2023-01-02,2.91,
+8HXA,2023-01-04,3.04,
+8HXC,2023-01-04,3.12,
+8I0N,2023-01-11,3.26,
+8I0Q,2023-01-11,4.45,
+8I0Z,2023-01-12,4.33,
+8I10,2023-01-12,3.96,
+8I3S,2023-01-17,3.9,
+8I3U,2023-01-18,3.6,
+8I4E,2023-01-19,3.98,
+8I4F,2023-01-19,3.44,
+8I4G,2023-01-19,3.68,
+8I4H,2023-01-19,3.81,
+8I5H,2023-01-25,2.38,
+8I5I,2023-01-25,3.06,
+8I95,2023-02-06,2.88,
+8I97,2023-02-06,3.19,
+8I9A,2023-02-06,3.57,
+8I9L,2023-02-07,3.18,
+8I9S,2023-02-07,3.26,
+8IA2,2023-02-07,3.21,
+8IC0,2023-02-10,3.41,
+8IDN,2023-02-13,3.35,
+8IJS,2023-02-28,1.752,
+8IJZ,2023-02-28,,
+8ILX,2023-03-05,3.29,
+8IM0,2023-03-05,1.31,
+8IM1,2023-03-05,2.05,
+8ITU,2023-03-23,3.68,
+8IUY,2023-03-25,2.9,
+8IUZ,2023-03-25,3.0,
+8IV0,2023-03-25,2.9,
+8IV4,2023-03-26,3.59,
+8IV5,2023-03-26,3.77,
+8IV8,2023-03-26,3.92,
+8IVA,2023-03-26,3.95,
+8IX3,2023-03-31,3.98,
+8J1T,2023-04-13,3.3,
+8J1V,2023-04-13,3.01,
+8J5J,2023-04-23,3.0,
+8J6I,2023-04-26,2.92,
+8J7S,2023-04-28,2.84,
+8J8R,2023-05-02,2.9,
+8J8V,2023-05-02,3.22,
+8J8Z,2023-05-02,3.4,
+8J97,2023-05-02,3.2,
+8J9K,2023-05-03,3.5,
+8JA3,2023-05-05,3.94,
+8JA5,2023-05-05,2.79,
+8JAF,2023-05-05,3.1,
+8JKF,2023-06-01,2.83,
+8JKH,2023-06-01,2.64,
+8JLJ,2023-06-02,3.1,
+8JLK,2023-06-02,3.22,
+8JLN,2023-06-02,3.24,
+8JLQ,2023-06-02,2.84,
+8JLR,2023-06-02,3.0,
+8JQM,2023-06-14,2.8,
+8JQN,2023-06-14,2.8,
+8JQS,2023-06-14,2.63,
+8JR3,2023-06-16,3.22,
+8JSO,2023-06-20,3.4,
+8JVA,2023-06-28,2.81,
+8JZP,2023-07-06,3.45,
+8JZZ,2023-07-06,3.31,
+8K3C,2023-07-15,2.88,
+8K3K,2023-07-16,2.43,
+8K45,2023-07-17,3.66,
+8K46,2023-07-17,3.37,
+8K47,2023-07-17,3.54,
+8K5G,2023-07-21,3.41,
+8K5H,2023-07-21,3.22,
+8KDM,2023-08-09,2.87,
+8KDR,2023-08-10,3.4,
+8KDS,2023-08-10,3.05,
+8KDT,2023-08-10,3.04,
+8KEH,2023-08-11,3.21,
+8KEJ,2023-08-11,3.73,
+8KEK,2023-08-11,3.54,
+8KEO,2023-08-13,2.78,
+8KEP,2023-08-13,2.93,
+8KEQ,2023-08-13,3.14,
+8KER,2023-08-13,2.95,
+8KFA,2023-08-15,3.04,
+8KG5,2023-08-17,3.17,
+8KHR,2023-08-22,3.25,
+8SAK,2023-04-01,3.0,
+8SAL,2023-04-01,4.9,
+8SAN,2023-04-01,4.6,
+8SAQ,2023-04-01,3.9,
+8SAR,2023-04-01,3.82,
+8SAS,2023-04-01,4.0,
+8SAT,2023-04-02,4.5,
+8SAU,2023-04-02,3.3,
+8SAV,2023-04-02,4.0,
+8SAW,2023-04-02,3.3,
+8SAX,2023-04-02,4.0,
+8SAY,2023-04-02,3.4,
+8SAZ,2023-04-02,3.9,
+8SB0,2023-04-02,4.2,
+8SB1,2023-04-02,4.3,
+8SB2,2023-04-02,3.5,
+8SB3,2023-04-02,4.1,
+8SB4,2023-04-02,3.6,
+8SB5,2023-04-02,3.9,
+8SGN,2023-04-12,2.2,
+8SGO,2023-04-12,2.65,
+8SIC,2023-04-14,2.76,
+8SM0,2023-04-25,1.68,
+8SM1,2023-04-25,3.29,
+8SMI,2023-04-26,3.5,
+8SMT,2023-04-26,3.16,
+8SUO,2023-05-12,3.3,
+8SW7,2023-05-17,3.73,
+8SWH,2023-05-18,3.88,
+8SWV,2023-05-19,3.37,
+8SWW,2023-05-19,3.4,
+8SWX,2023-05-19,3.9,
+8SX3,2023-05-19,4.0,
+8SXI,2023-05-22,4.5,
+8SXJ,2023-05-22,4.0,
+8SZY,2023-05-30,2.31,
+8T12,2023-06-01,3.34,
+8T13,2023-06-01,3.45,
+8T1G,2023-06-02,3.5,
+8T49,2023-06-08,3.2,
+8T4A,2023-06-08,3.4,
+8T4B,2023-06-08,3.5,
+8T4D,2023-06-09,3.1,
+8T4L,2023-06-09,3.2,
+8T5C,2023-06-13,4.7,
+8T7A,2023-06-20,2.8,
+8T9Z,2023-06-26,2.995,
+8TBQ,2023-06-29,2.593,
+8TCO,2023-07-02,2.8,
+8TGO,2023-07-12,5.75,
+8TH3,2023-07-13,3.0,
+8TH4,2023-07-13,3.3,
+8TJN,2023-07-23,3.73,
+8TJO,2023-07-23,3.61,
+8TJR,2023-07-24,3.29,
+8TJS,2023-07-24,3.31,
+8TKC,2023-07-25,3.1,
+8TL2,2023-07-26,3.2,
+8TL3,2023-07-26,3.1,
+8TL4,2023-07-26,3.2,
+8TL5,2023-07-26,3.3,
+8TM1,2023-07-27,2.79,
+8TMA,2023-07-29,3.2,
+8TMY,2023-07-31,3.07,
+8TMZ,2023-07-31,1.8,
+8TNG,2023-08-01,3.58,
+8TNH,2023-08-01,3.32,
+8TNI,2023-08-01,3.61,
+8TNL,2023-08-02,3.62,
+8TNU,2023-08-02,3.36,
+8TO7,2023-08-03,3.39,
+8TO9,2023-08-03,4.03,
+8TOA,2023-08-03,3.69,
+8TOP,2023-08-03,3.52,
+8TP2,2023-08-04,3.1,
+8TP3,2023-08-04,3.6,
+8TP4,2023-08-04,3.3,
+8TP5,2023-08-04,2.9,
+8TP6,2023-08-04,3.1,
+8TP7,2023-08-04,2.8,
+8TP9,2023-08-04,3.1,
+8TPA,2023-08-04,3.0,
+8TQ1,2023-08-06,3.3,
+8TQI,2023-08-07,3.24,
+8TQK,2023-08-07,3.2,
+8TR3,2023-08-09,3.74,
+8TRS,2023-08-10,1.9,
+8TRT,2023-08-10,3.0,
+8TRV,2023-08-10,3.25,
+8TS5,2023-08-10,2.1,
+8TTF,2023-08-13,3.61,
+8TTH,2023-08-13,3.54,
+8TV1,2023-08-17,2.6,
+8TV2,2023-08-17,2.65,
+8TV5,2023-08-17,4.6,
+8TVD,2023-08-18,3.077,
+8TVH,2023-08-18,3.6,
+8TVJ,2023-08-18,3.168,
+8TW3,2023-08-19,2.9,
+8TXM,2023-08-23,3.25,
+8TXP,2023-08-24,2.75,
+8TXT,2023-08-24,3.19,
+8TY7,2023-08-24,3.21,
+8TYC,2023-08-24,3.3,
+8TYE,2023-08-25,3.8,
+8TZY,2023-08-28,3.8,
+8TZZ,2023-08-28,3.56,
+8U31,2023-09-07,2.73,
+8U32,2023-09-07,2.51,
+8U3Y,2023-09-08,3.1,
+8U44,2023-09-08,3.41,
+8U4Q,2023-09-11,3.36,
+8U4R,2023-09-11,3.1,
+8U4S,2023-09-11,3.35,
+8U4T,2023-09-11,3.38,
+8U5L,2023-09-12,2.7,
+8U9Y,2023-09-20,3.7,
+8UCD,2023-09-26,3.0,
+8UDG,2023-09-28,4.98,
+8UDZ,2023-09-29,2.21,
+8UG9,2023-10-05,3.49,
+8ULH,2023-10-16,1.69,
+8ULJ,2023-10-16,3.0,
+8ULK,2023-10-16,4.28,
+8US0,2023-10-27,3.7,
+8UT3,2023-10-30,2.8,
+8UT4,2023-10-30,3.3,
+8UT5,2023-10-30,3.5,
+8UT6,2023-10-30,2.8,
+8UT7,2023-10-30,2.7,
+8UT8,2023-10-30,3.2,
+8UT9,2023-10-30,3.3,
+8UWA,2023-11-06,4.02,
+8V4F,2023-11-29,2.68,
+8V5A,2023-11-30,3.0,
+8V5K,2023-11-30,2.6,
+8V62,2023-12-01,3.4,
+8V7O,2023-12-04,3.57,
+8V91,2023-12-07,2.6,
+8V93,2023-12-07,3.12,
+8V9D,2023-12-07,2.9,
+8VCV,2023-12-14,2.8,
+8VE8,2023-12-18,2.8,
+8VFV,2023-12-22,3.3,
+8VGN,2023-12-27,2.5,
+8VGO,2023-12-27,2.6,
+8VGV,2023-12-29,3.6,
+8VGW,2023-12-29,3.9,
+8VH1,2023-12-30,4.08,
+8VH2,2023-12-30,4.31,
+8VIF,2024-01-04,3.1,
+8VKE,2024-01-09,3.1,
+8VKK,2024-01-09,2.81,
+8VKL,2024-01-09,2.91,
+8VKM,2024-01-09,2.83,
+8VKN,2024-01-09,2.93,
+8VKO,2024-01-09,2.68,
+8VKP,2024-01-09,2.77,
+8VUJ,2024-01-29,3.92,
+8VUL,2024-01-29,3.83,
+8VUN,2024-01-29,4.01,
+8VUQ,2024-01-29,3.85,
+8VUR,2024-01-29,3.84,
+8VUS,2024-01-29,3.99,
+8VUT,2024-01-29,3.7,
+8VUU,2024-01-29,4.05,
+8VUV,2024-01-29,3.69,
+8VVK,2024-01-31,2.61,
+8VVL,2024-01-31,1.8,
+8VWW,2024-02-02,3.9,
+8VYE,2024-02-08,2.7,
+8VYF,2024-02-08,3.2,
+8VYG,2024-02-08,3.1,
+8VYM,2024-02-09,3.4,
+8VYN,2024-02-09,2.8,
+8W0V,2024-02-14,2.59,
+8W0W,2024-02-14,2.13,
+8W0X,2024-02-14,3.12,
+8W0Y,2024-02-14,3.31,
+8W2Z,2024-02-21,3.37,
+8W4F,2023-08-24,4.2,
+8W90,2023-09-04,1.81,
+8WLJ,2023-09-30,3.6,
+8WNP,2023-10-06,3.1,
+8WNU,2023-10-06,3.8,
+8WO4,2023-10-06,2.8,
+8WPW,2023-10-10,2.49,
+8WPY,2023-10-10,3.02,
+8WSN,2023-10-17,2.8,
+8WSP,2023-10-17,2.51,
+8WSU,2023-10-17,3.3,
+8X0T,2023-11-06,2.5,
+8X0X,2023-11-06,3.45,
+8X0Y,2023-11-06,1.94,
+8X16,2023-11-06,3.29,
+8X3L,2023-11-14,3.13,
+8XC4,2023-12-08,3.24,
+8XCD,2023-12-08,3.49,
+8XE9,2023-12-11,3.3,
+8XEA,2023-12-11,3.42,
+8XEF,2023-12-11,4.41,
+8XGO,2023-12-15,2.68,
+8XGS,2023-12-15,2.95,
+8XGU,2023-12-15,3.0,
+8XI6,2023-12-19,2.3,
+8XIO,2023-12-19,2.65,
+8XIP,2023-12-19,3.29,
+8XK2,2023-12-22,3.4,
+8XKC,2023-12-23,2.18,
+8XKE,2023-12-23,1.92,
+8XKI,2023-12-23,3.2,
+8XN9,2023-12-29,1.99,
+8XNH,2023-12-30,2.3,
+8XOF,2024-01-01,2.6,
+8XOG,2024-01-01,2.9,
+8XOH,2024-01-01,3.2,
+8XOI,2024-01-01,3.2,
+8XOJ,2024-01-01,3.1,
+8XS3,2024-01-08,3.46,
+8XSE,2024-01-09,2.5,
+8XSI,2024-01-09,2.1,
+8XSL,2024-01-09,3.2,
+8XVU,2024-01-15,3.09,
+8XWA,2024-01-16,3.48,
+8XWF,2024-01-16,3.65,
+8XWM,2024-01-16,3.71,
+8XWN,2024-01-16,3.29,
+8XWS,2024-01-16,3.06,
+8XX3,2024-01-17,3.38,
+8XX6,2024-01-17,2.99,
+8XX7,2024-01-17,3.32,
+8XXH,2024-01-18,2.8,
+8XXR,2024-01-18,3.17,
+8XXW,2024-01-19,3.03,
+8XXX,2024-01-19,3.17,
+8Y3O,2024-01-29,2.75,
+8Y3P,2024-01-29,3.48,
+8Y3Q,2024-01-29,2.98,
+8Y3R,2024-01-29,3.48,
+8Y4A,2024-01-30,3.4,
+8Y4C,2024-01-30,3.75,
+8Y4W,2024-01-31,3.16,
+8Y4X,2024-01-31,3.2,
+8Y53,2024-01-31,2.93,
+8Y6A,2024-02-02,2.72,
+8YHZ,2024-02-28,1.62,
+8YJ5,2024-03-01,3.66,
+8YJ7,2024-03-01,2.8,
+8YJ8,2024-03-01,1.65,
+8YKV,2024-03-05,2.48,
+8YKW,2024-03-05,2.75,
+8YKX,2024-03-05,2.69,
+8YRO,2024-03-21,3.27,
+8YRP,2024-03-21,3.64,
+8YUT,2024-03-27,2.7,
+8YUU,2024-03-27,2.7,
+8YUV,2024-03-27,3.0,
+8YWA,2024-03-30,3.14,
+8YWW,2024-04-01,2.7,
+8YWX,2024-04-01,3.4,
+8YXI,2024-04-02,2.4,
+8YZ5,2024-04-06,3.93,
+8YZ6,2024-04-06,4.55,
+8ZBE,2024-04-26,3.24,
+4LQD,2013-07-17,2.451,
+4LQF,2013-07-17,2.3,
+4LRI,2013-07-19,1.65,
+4LRN,2013-07-20,1.89,
+4LU5,2013-07-24,2.9,
+4LVH,2013-07-26,2.8,
+4LZP,2013-08-01,3.15,
+4M1D,2013-08-02,1.8,
+4M1G,2013-08-02,1.6,
+4M3J,2013-08-06,1.95,
+4M43,2013-08-06,1.85,
+4M5Y,2013-08-08,1.55,
+4M61,2013-08-08,1.62,
+4M62,2013-08-08,1.8,
+4M6M,2013-08-09,2.0,
+4M6N,2013-08-09,2.0,
+4M6O,2013-08-09,2.8,
+4M7J,2013-08-12,1.95,
+4M7K,2013-08-12,1.9,
+4M7Z,2013-08-12,2.75,
+4M8Q,2013-08-13,2.89,
+4M8V,2013-08-14,1.951,
+4M93,2013-08-14,2.09,
+4M9O,2013-08-15,2.14,
+4MA1,2013-08-15,2.32,
+4MA3,2013-08-15,2.0,
+4MA7,2013-08-15,1.97,
+4MA8,2013-08-15,2.2,
+4MAU,2013-08-16,1.9,
+4MAY,2013-08-18,2.2,
+4MCY,2013-08-22,2.3,
+4MCZ,2013-08-22,2.41,
+4MD0,2013-08-22,2.194,
+4MD4,2013-08-22,1.95,
+4MD5,2013-08-22,1.65,
+4MDI,2013-08-22,2.0,
+4MDJ,2013-08-22,1.7,
+4MHE,2013-08-29,2.1,
+4MI1,2013-08-30,1.4,
+4MJI,2013-09-03,2.99,
+4MJX,2013-09-04,1.4,
+4MNG,2013-09-10,3.0058,
+4MNH,2013-09-10,3.3,
+4MNQ,2013-09-11,2.742,
+4MQ7,2013-09-15,2.6032,
+4MS8,2013-09-18,1.922,
+4MSV,2013-09-18,2.5,
+4MUC,2013-09-21,2.897,
+4MVB,2013-09-23,3.088,
+4MWF,2013-09-24,2.645,
+4MX7,2013-09-25,2.24,
+4MXQ,2013-09-26,2.596,
+4N0C,2013-10-01,2.9,
+4N0F,2013-10-01,3.02,
+4N0Y,2013-10-02,1.749,
+4N5E,2013-10-09,3.059,
+4N8C,2013-10-17,1.6,
+4N8P,2013-10-17,2.299,
+4N8V,2013-10-18,2.5,
+4N9G,2013-10-21,2.5,
+4NBX,2013-10-23,1.75,
+4NBY,2013-10-23,2.08,
+4NBZ,2013-10-23,1.75,
+4NC0,2013-10-23,2.3,
+4NC1,2013-10-23,2.61,
+4NC2,2013-10-23,2.5,
+4NCC,2013-10-24,2.49,
+4NDM,2013-10-27,3.0065,
+4NEJ,2013-10-29,1.919,
+4NEM,2013-10-29,1.934,
+4NFB,2013-10-31,1.6,
+4NFC,2013-10-31,2.2,
+4NFD,2013-10-31,1.708,
+4NGH,2013-11-01,2.68,
+4NHC,2013-11-04,2.912,
+4NHG,2013-11-05,8.001,
+4NHH,2013-11-05,6.5,
+4NHU,2013-11-05,2.9,
+4NJ9,2013-11-08,1.95,
+4NJA,2013-11-08,2.204,
+4NM4,2013-11-14,2.65,
+4NOB,2013-11-19,1.51,
+4NOF,2013-11-19,1.65,
+4NOO,2013-11-20,2.3,
+4NP4,2013-11-20,2.89,
+4NPY,2013-11-22,1.796,
+4NQC,2013-11-25,2.5,
+4NQD,2013-11-25,2.2,
+4NQE,2013-11-25,2.1,
+4NQS,2013-11-25,2.64,
+4NQT,2013-11-25,2.1,
+4NQU,2013-11-25,2.5,
+4NRX,2013-11-27,2.21,
+4NRY,2013-11-27,3.14,
+4NRZ,2013-11-27,2.42,
+4NT6,2013-12-01,1.84,
+4NUG,2013-12-03,1.8617,
+4NUJ,2013-12-03,1.827,
+4NUX,2013-12-04,2.295,
+4NWT,2013-12-06,1.75,
+4NWU,2013-12-06,1.602,
+4NYL,2013-12-10,2.8,
+4NYT,2013-12-11,2.25,
+4NZU,2013-12-12,1.2,
+4O2C,2013-12-17,1.802,
+4O2E,2013-12-17,1.981,
+4O2F,2013-12-17,1.901,
+4O4Y,2013-12-19,1.85,
+4O51,2013-12-19,2.204,
+4O5L,2013-12-19,1.5045,
+4O6K,2013-12-21,2.1,
+4O9H,2014-01-02,2.42,
+4OAW,2014-01-06,2.8,
+4OB5,2014-01-06,1.7,
+4OCR,2014-01-09,1.895,
+4OCS,2014-01-09,1.901,
+4OCW,2014-01-09,3.001,
+4OCX,2014-01-09,2.39,
+4OCY,2014-01-09,2.79,
+4OD1,2014-01-09,2.69,
+4OD3,2014-01-09,2.616,
+4ODH,2014-01-10,2.894,
+4ODS,2014-01-10,1.94,
+4ODT,2014-01-10,1.95,
+4ODU,2014-01-10,2.29,
+4ODV,2014-01-10,2.15,
+4ODW,2014-01-10,2.72,
+4ODX,2014-01-10,3.1,
+4OJF,2014-01-21,1.998,
+4ONF,2014-01-28,2.0,
+4ONG,2014-01-28,2.2,
+4ONH,2014-01-28,3.008,
+4ONO,2014-01-28,2.705,
+4ONT,2014-01-29,2.15,
+4OPP,2014-02-06,2.3,
+4ORG,2014-02-11,3.121,
+4ORV,2014-02-12,2.5,
+4OSU,2014-02-13,1.87,
+4OTX,2014-02-14,2.1,
+4OUG,2014-02-17,2.46,
+4OUO,2014-02-18,1.8,
+4OV5,2014-02-20,2.199,
+4OZF,2014-02-15,2.7,
+4OZG,2014-02-16,3.0,
+4OZH,2014-02-16,2.8,
+4OZI,2014-02-16,3.2,
+4P23,2014-02-28,2.25,
+4P2O,2014-03-04,2.603,
+4P2Q,2014-03-04,3.3,
+4P2R,2014-03-04,3.295,
+4P39,2014-03-06,2.401,
+4P3A,2014-03-06,1.4,
+4P3B,2014-03-06,2.1,
+4P3C,2014-03-06,1.943,
+4P3D,2014-03-07,1.949,
+4P46,2014-03-11,2.851,
+4P48,2014-03-12,1.35,
+4P49,2014-03-12,1.4,
+4P4K,2014-03-12,2.8,
+4P4R,2014-03-13,3.0,
+4P57,2014-03-14,2.6,
+4P5K,2014-03-17,2.59,
+4P5M,2014-03-18,1.7,
+4P5T,2014-03-19,3.263,
+4P9M,2014-04-04,2.13,
+4PB0,2014-04-10,2.5,
+4PB9,2014-04-11,2.6,
+4PBO,2014-04-13,1.701,
+4PBP,2014-04-13,1.648,
+4PG2,2014-05-01,2.8,
+4PJ5,2014-05-12,2.0,
+4PJ7,2014-05-12,2.5,
+4PJ8,2014-05-12,3.3,
+4PJ9,2014-05-12,2.0,
+4PJA,2014-05-12,2.68,
+4PJB,2014-05-12,2.85,
+4PJC,2014-05-12,2.5,
+4PJD,2014-05-12,2.78,
+4PJE,2014-05-12,1.95,
+4PJF,2014-05-12,2.45,
+4PJG,2014-05-12,2.4,
+4PJH,2014-05-12,2.0,
+4PJI,2014-05-12,2.5,
+4PJX,2014-05-12,2.25,
+4PO4,2014-02-24,2.5,
+4POY,2014-02-26,1.5,
+4POZ,2014-02-26,1.75,
+4PP8,2014-02-26,1.95,
+4PPT,2014-02-27,1.5,
+4PR5,2014-03-05,1.8,
+4PRA,2014-03-05,1.85,
+4PRB,2014-03-05,1.75,
+4PRD,2014-03-05,1.75,
+4PRE,2014-03-05,1.65,
+4PRH,2014-03-05,2.5,
+4PRI,2014-03-05,2.4,
+4PRN,2014-03-06,1.65,
+4PRP,2014-03-06,2.5,
+4PS4,2014-03-06,2.8,
+4PTT,2014-03-11,1.8,
+4PTU,2014-03-11,1.511,
+4PUB,2014-03-12,1.75,
+4PV8,2014-03-15,2.31,
+4PV9,2014-03-15,2.0,
+4PWS,2014-03-21,2.15,
+4PY7,2014-03-26,2.7,
+4Q2Z,2014-04-10,1.93,
+4Q3H,2014-04-11,1.443,
+4Q6I,2014-04-22,3.65,
+4Q6Y,2014-04-23,3.0,
+4Q74,2014-04-24,2.19,
+4Q7D,2014-04-24,2.35,
+4Q7O,2014-04-25,1.45,
+4Q8S,2014-04-28,2.09,
+4Q97,2014-04-29,2.4,
+4Q9B,2014-04-30,1.5,
+4Q9C,2014-04-30,2.8,
+4Q9E,2014-05-01,2.31,
+4Q9V,2014-05-02,2.3,
+4QDH,2014-05-13,2.399,
+4QEX,2014-05-19,4.5,
+4QF1,2014-05-19,2.4,
+4QGT,2014-05-25,2.99,
+4QGY,2014-05-26,1.38,
+4QHK,2014-05-28,3.487,
+4QHL,2014-05-28,3.153,
+4QHM,2014-05-28,3.23,
+4QHN,2014-05-28,3.0,
+4QHU,2014-05-29,2.2,
+4QKG,2014-06-06,1.95,
+4QKH,2014-06-06,1.8,
+4QKI,2014-06-06,1.8,
+4QKJ,2014-06-06,2.75,
+4QLR,2014-06-13,1.7,
+4QOK,2014-06-20,3.0,
+4QRP,2014-07-02,2.9,
+4QRQ,2014-07-02,1.7,
+4QRR,2014-07-02,3.0,
+4QRS,2014-07-02,1.4,
+4QRT,2014-07-02,1.4,
+4QRU,2014-07-02,1.6,
+4QT5,2014-07-07,2.5,
+4QTH,2014-07-08,2.17,
+4QTI,2014-07-08,3.0,
+4QXG,2014-07-20,2.3,
+4QXO,2014-07-21,1.88,
+4QXP,2014-07-21,2.51,
+4QXQ,2014-07-21,2.42,
+4QXR,2014-07-21,2.37,
+4QXT,2014-07-22,1.58,
+4QXU,2014-07-22,2.3,
+4QY8,2014-07-24,1.353,
+4QYO,2014-07-24,1.208,
+4R07,2014-07-30,2.0,
+4R08,2014-07-30,2.4,
+4R09,2014-07-30,2.62,
+4R0A,2014-07-30,1.9,
+4R0L,2014-07-31,3.3,
+4R26,2014-08-08,2.4969,
+4R2G,2014-08-11,3.283,
+4R3S,2014-08-18,1.7,
+4R4B,2014-08-19,2.199,
+4R6U,2014-08-26,2.8,
+4R7D,2014-08-27,2.753,
+4R7N,2014-08-28,3.45,
+4R8W,2014-09-03,2.795,
+4R90,2014-09-03,1.746,
+4R96,2014-09-03,3.31,
+4R97,2014-09-03,2.2,
+4R9H,2014-09-05,1.9,
+4RA3,2014-09-09,2.8,
+4RAH,2014-09-10,1.4,
+4RAU,2014-09-11,3.74,
+4RBP,2014-09-12,1.85,
+4RFE,2014-09-25,1.91,
+4RIR,2014-10-07,2.5,
+4RIS,2014-10-07,2.3,
+4RMQ,2014-10-22,1.461,
+4RMR,2014-10-22,1.529,
+4RMS,2014-10-22,1.7,
+4RMT,2014-10-22,1.242,
+4RMU,2014-10-22,1.4,
+4RMV,2014-10-22,1.463,
+4RMW,2014-10-22,1.4,
+4RNR,2014-10-24,2.758,
+4RQQ,2014-11-04,3.1,
+4RQS,2014-11-05,4.493,
+4RRP,2014-11-06,2.79,
+4RSU,2014-11-11,2.3,
+4RZC,2014-12-19,2.723,
+4S0S,2015-01-05,2.8,
+4S0U,2015-01-06,2.35,
+4S11,2015-01-07,1.998,
+4S1D,2015-01-13,2.5,
+4S2S,2015-01-22,2.1,
+4TOY,2014-06-06,1.551,
+4TPR,2014-06-09,1.6,
+4TQE,2014-06-11,1.6,
+4TRP,2014-06-17,1.25,
+4TTD,2014-06-20,2.15,
+4TUJ,2014-06-24,1.89,
+4TUK,2014-06-24,1.6,
+4TUL,2014-06-24,1.4,
+4TUO,2014-06-24,1.55,
+4TYU,2014-07-09,2.13,
+4U05,2014-07-11,2.5,
+4U0R,2014-07-14,2.3,
+4U1G,2014-07-15,3.1,
+4U1H,2014-07-15,1.59,
+4U1I,2014-07-15,1.92,
+4U1J,2014-07-15,1.38,
+4U1K,2014-07-15,2.09,
+4U1L,2014-07-15,2.06,
+4U1M,2014-07-15,1.18,
+4U1N,2014-07-15,1.77,
+4U1S,2014-07-16,1.76,
+4U3X,2014-07-23,2.26,
+4U6G,2014-07-28,4.2012,
+4U6H,2014-07-29,3.1,
+4U6V,2014-07-29,2.56,
+4U6X,2014-07-30,1.68,
+4U6Y,2014-07-30,1.467,
+4U7S,2014-07-31,2.07,
+4UB0,2014-08-11,2.2,
+4UDT,2014-12-11,1.35,
+4UDU,2014-12-11,2.5,
+4UIK,2015-03-30,2.0,
+4UIL,2015-03-30,2.853,
+4UIM,2015-03-30,2.7,
+4UIN,2015-03-30,2.5,
+4UM8,2014-05-15,2.852,
+4UM9,2014-05-15,2.5,
+4UNT,2014-05-30,2.7,
+4UNU,2014-05-30,0.95,
+4UNV,2014-05-30,1.6,
+4UOK,2014-06-04,18.0,
+4UQ2,2014-06-19,2.43,
+4UQ3,2014-06-19,2.1,
+4UT7,2014-07-18,1.7,
+4UU9,2014-07-25,2.12,
+4UV4,2014-08-04,3.08,
+4UW2,2014-08-08,2.632,
+4V0P,2014-09-17,2.07,
+4V1P,2014-09-30,2.04,
+4W2O,2017-08-17,3.2,
+4W2P,2017-08-17,1.77,
+4W2Q,2017-08-17,2.7,
+4W4N,2014-08-15,1.8,
+4W4O,2014-08-15,1.8,
+4W68,2014-08-20,2.0,
+4W70,2014-08-21,2.28,
+4W81,2014-08-22,2.25,
+4WC8,2014-09-04,1.908,
+4WCO,2014-09-05,2.46,
+4WCY,2014-09-05,2.0,
+4WDI,2014-09-08,2.313,
+4WI2,2014-09-25,1.9,
+4WI3,2014-09-25,2.703,
+4WI4,2014-09-25,2.8,
+4WI5,2014-09-25,2.8,
+4WI6,2014-09-25,2.201,
+4WI7,2014-09-25,1.9,
+4WI8,2014-09-25,2.8,
+4WI9,2014-09-25,2.65,
+4WJ0,2014-09-29,2.85,
+4WJ5,2014-09-29,1.65,
+4WNQ,2014-10-14,1.8,
+4WO4,2014-10-15,2.5,
+4WU5,2014-10-31,2.4,
+4WU7,2014-10-31,2.297,
+4WUK,2014-11-01,1.7,
+4WUU,2014-11-03,3.047,
+4WW1,2014-11-10,1.38,
+4WW2,2014-11-10,2.48,
+4WWK,2014-11-11,3.1,
+4WY7,2014-11-16,2.1,
+4X0K,2014-11-21,2.04,
+4X0S,2014-11-23,2.032,
+4X37,2014-11-28,1.63,
+4X38,2014-11-28,2.12,
+4X39,2014-11-28,1.61,
+4X3A,2014-11-28,1.75,
+4X4M,2014-12-03,3.485,
+4X4X,2014-12-04,2.25,
+4X4Z,2014-12-04,1.8,
+4X51,2014-12-04,2.05,
+4X52,2014-12-04,2.08,
+4X5W,2014-12-06,1.34,
+4X5X,2014-12-06,3.199,
+4X6B,2014-12-07,2.1,
+4X6C,2014-12-08,2.8,
+4X6D,2014-12-08,2.98,
+4X6E,2014-12-08,2.1,
+4X6F,2014-12-08,1.91,
+4X7S,2014-12-09,1.9,
+4X7T,2014-12-09,3.0,
+4X80,2014-12-09,2.6,
+4X8J,2014-12-10,2.35,
+4X98,2014-12-11,2.499,
+4X99,2014-12-11,2.498,
+4XAK,2014-12-15,2.45,
+4XAW,2014-12-15,1.47,
+4XBE,2014-12-16,1.756,
+4XBG,2014-12-16,2.73,
+4XBP,2014-12-17,2.94,
+4XC1,2014-12-17,1.63,
+4XC2,2014-12-17,1.9,
+4XC3,2014-12-17,1.63,
+4XCC,2014-12-17,2.81,
+4XCE,2014-12-17,2.93,
+4XCF,2014-12-17,1.43,
+4XCN,2014-12-18,2.9,
+4XCY,2014-12-18,3.96,
+4XML,2015-01-14,2.68,
+4XMP,2015-01-15,1.7831,
+4XNY,2015-01-16,2.3,
+4XNZ,2015-01-16,3.389,
+4XSQ,2015-01-22,1.79,
+4XVJ,2015-01-27,2.0,
+4XW2,2015-01-28,2.001,
+4XXC,2015-01-30,1.426,
+4XXD,2015-01-30,2.41,
+4XZU,2015-02-05,2.61,
+4XZX,2015-02-05,2.2,
+4Y16,2015-02-06,2.6,
+4Y19,2015-02-07,2.5,
+4Y1A,2015-02-07,4.0,
+4Y1S,2015-02-09,1.611,
+4Y1T,2015-02-09,2.666,
+4Y2D,2015-02-09,3.05,
+4Y4F,2015-02-10,3.19,
+4Y4H,2015-02-10,3.1,
+4Y4K,2015-02-10,2.9,
+4YAQ,2015-02-17,2.3,
+4YDI,2015-02-22,3.452,
+4YDJ,2015-02-22,2.308,
+4YDK,2015-02-22,2.051,
+4YDL,2015-02-22,1.8,
+4YDV,2015-02-23,2.7,
+4YFL,2015-02-25,3.387,
+4YGV,2015-02-26,1.76,
+4YH6,2015-02-27,3.0,
+4YHI,2015-02-27,1.9,
+4YHK,2015-02-27,2.21,
+4YHL,2015-02-27,2.09,
+4YHM,2015-02-27,2.16,
+4YHN,2015-02-27,2.31,
+4YHO,2015-02-27,1.82,
+4YHP,2015-02-27,2.53,
+4YHY,2015-02-27,1.9,
+4YHZ,2015-02-27,2.304,
+4YIV,2015-03-02,1.93,
+4YIZ,2015-03-02,2.2,
+4YNY,2015-03-11,1.584,
+4YO0,2015-03-11,1.56,
+4YP1,2015-03-12,2.65,
+4YPG,2015-03-12,3.0,
+4YR6,2015-03-14,2.38,
+4YS2,2015-03-16,1.968,
+4YS4,2015-03-16,2.45,
+4YX2,2015-03-22,2.194,
+4YXH,2015-03-23,2.7,
+4YXK,2015-03-23,2.805,
+4YXL,2015-03-23,2.604,
+4YY0,2015-03-23,2.59,
+4YY1,2015-03-23,3.1,
+4YY7,2015-03-23,2.99,
+4YY9,2015-03-23,2.601,
+4YYA,2015-03-23,2.595,
+4YYB,2015-03-23,2.609,
+4YZF,2015-03-25,3.5,
+4Z0B,2015-03-26,3.2,
+4Z0C,2015-03-26,2.3,
+4Z0X,2015-03-26,2.0,
+4Z76,2015-04-06,1.88,
+4Z77,2015-04-06,1.85,
+4Z78,2015-04-06,2.304,
+4Z7U,2015-04-08,2.7,
+4Z7V,2015-04-08,2.65,
+4Z7W,2015-04-08,2.89,
+4ZAK,2015-04-13,2.824,
+4ZBH,2015-04-14,1.5,
+4ZD3,2015-04-16,2.4,
+4ZDH,2015-04-17,2.0984,
+4ZF7,2015-04-21,1.893,
+4ZFO,2015-04-21,1.895,
+4ZFZ,2015-04-22,1.763,
+4ZH1,2015-04-24,2.24,
+4ZJS,2015-04-29,2.2301,
+4ZK0,2015-04-29,2.15,
+4ZK3,2015-04-29,2.0,
+4ZNE,2015-05-04,2.42,
+4ZQK,2015-05-10,2.45,
+4ZQV,2015-05-11,1.803,
+4ZS6,2015-05-13,3.166,
+4ZS7,2015-05-13,2.93,
+4ZSO,2015-05-13,2.5,
+4ZTO,2015-05-14,2.3,
+4ZTP,2015-05-14,1.63,
+4ZUS,2015-05-17,2.6,
+4ZUT,2015-05-17,2.6,
+4ZUU,2015-05-17,2.2,
+4ZUV,2015-05-17,2.3,
+4ZUW,2015-05-17,2.6,
+4ZYK,2015-05-21,2.0,
+4ZYP,2015-05-21,5.5,
+5A10,2015-04-27,1.423,
+5A11,2015-04-27,2.47,
+5A16,2015-04-28,2.5,
+5A2E,2015-05-18,3.15,
+5A2I,2015-05-20,1.88,
+5A2K,2015-05-20,1.7,
+5A2L,2015-05-20,1.79,
+5A2U,2015-05-25,3.3,
+5A6P,2015-06-30,2.1,
+5AAM,2015-07-27,2.49,
+5ACL,2015-08-17,1.49,
+5ACM,2015-08-17,1.05,
+5ACZ,2015-08-19,2.69,
+5AD0,2015-08-19,2.84,
+5ADO,2015-08-21,1.55,
+5ADP,2015-08-21,2.13,
+5AEO,2015-01-07,1.8,
+5ALB,2015-03-07,2.16,
+5ALC,2015-03-07,1.7,
+5ANM,2015-09-07,2.85,
+5AWA,2015-07-03,2.2,
+5AWB,2015-07-03,2.1,
+5AWC,2015-07-03,2.5,
+5AWD,2015-07-03,2.05,
+5AWN,2015-07-06,1.887,
+5AYU,2015-09-04,1.8,
+5AZ2,2015-09-16,1.603,
+5AZ5,2015-09-27,2.4,
+5AZE,2015-10-02,2.2,
+5B1C,2015-12-02,2.003,
+5B1R,2015-12-15,1.2,
+5B38,2016-02-12,2.3,
+5B39,2016-02-12,2.5,
+5B3N,2016-03-04,1.94,
+5B4M,2016-04-05,2.4,
+5B6F,2016-05-27,2.1,
+5B71,2016-06-03,2.11,
+5B86,2016-06-12,3.017,
+5B8C,2016-06-14,2.146,
+5BK0,2017-09-12,3.15,
+5BK3,2017-09-12,2.8,
+5BK5,2017-09-12,3.0,
+5BMF,2015-05-22,2.8,
+5BMG,2015-05-22,2.2,
+5BMH,2015-05-22,1.6,
+5BMI,2015-05-22,2.5,
+5BQ7,2015-05-28,2.738,
+5BQX,2015-05-29,2.0,
+5BRZ,2015-06-01,2.62,
+5BS0,2015-06-01,2.4,
+5BUH,2015-06-03,2.55,
+5BVJ,2015-06-05,2.0,
+5BVP,2015-06-05,2.2,
+5BW7,2015-06-06,3.0,
+5BZD,2015-06-11,2.7,
+5BZW,2015-06-11,2.9,
+5C07,2015-06-12,2.11,
+5C08,2015-06-12,2.332,
+5C09,2015-06-12,2.475,
+5C0A,2015-06-12,2.46,
+5C0B,2015-06-12,2.03,
+5C0C,2015-06-12,1.974,
+5C0D,2015-06-12,1.68,
+5C0E,2015-06-12,1.491,
+5C0F,2015-06-12,1.463,
+5C0G,2015-06-12,1.37,
+5C0I,2015-06-12,1.53,
+5C0J,2015-06-12,1.64,
+5C2B,2015-06-15,1.4049,
+5C3T,2015-06-17,1.8,
+5C6W,2015-06-23,1.54,
+5C7K,2015-06-24,4.6019,
+5C7X,2015-06-25,2.95,
+5C9J,2015-06-27,2.4,
+5C9K,2015-06-27,1.92,
+5CBA,2015-06-30,2.5,
+5CBE,2015-06-30,2.4,
+5CCK,2015-07-02,1.95,
+5CD3,2015-07-02,2.9,
+5CD5,2015-07-03,3.396,
+5CER,2015-07-07,2.48,
+5CEX,2015-07-07,2.105,
+5CEY,2015-07-07,2.387,
+5CFH,2015-07-08,1.49,
+5CFL,2015-07-08,1.836,
+5CFM,2015-07-08,1.994,
+5CFN,2015-07-08,2.95,
+5CFO,2015-07-08,2.102,
+5CFP,2015-07-08,2.066,
+5CFQ,2015-07-08,2.099,
+5CFR,2015-07-08,2.85,
+5CGY,2015-07-09,2.07,
+5CHN,2015-07-10,2.047,
+5CIL,2015-07-13,1.81,
+5CIN,2015-07-13,1.7,
+5CIP,2015-07-13,2.48,
+5CJ8,2015-07-14,2.015,
+5CKA,2015-07-15,1.7,
+5CKG,2015-07-15,1.75,
+5CMA,2015-07-16,2.5,
+5CP3,2015-07-21,1.99,
+5CP7,2015-07-21,3.01,
+5CS7,2015-07-23,2.1,
+5CSB,2015-07-23,1.719,
+5CSG,2015-07-23,1.5,
+5CSZ,2015-07-23,1.8,
+5CZV,2015-08-01,3.19,
+5CZX,2015-08-01,2.1,
+5D14,2015-08-03,1.0,
+5D1Q,2015-08-04,3.22,
+5D1X,2015-08-04,3.21,
+5D1Z,2015-08-04,3.17,
+5D2L,2015-08-05,3.511,
+5D2N,2015-08-05,2.099,
+5D3D,2015-08-06,1.94,
+5D3I,2015-08-06,3.2,
+5D4K,2015-08-07,2.599,
+5D4Q,2015-08-08,2.39,
+5D5M,2015-08-11,2.2,
+5D6C,2015-08-12,1.72,
+5D6D,2015-08-12,3.13,
+5D70,2015-08-13,2.06,
+5D71,2015-08-13,2.25,
+5D72,2015-08-13,2.6,
+5D7I,2015-08-14,2.0,
+5D7J,2015-08-14,1.97,
+5D7K,2015-08-14,1.9,
+5D7L,2015-08-14,3.4,
+5D7S,2015-08-14,1.88,
+5D8J,2015-08-17,3.0,
+5D96,2015-08-18,2.3,
+5D9Q,2015-08-18,4.4,
+5D9S,2015-08-19,1.87,
+5DA4,2015-08-19,2.4,
+5DD0,2015-08-24,2.488,
+5DD1,2015-08-24,1.597,
+5DD3,2015-08-24,1.797,
+5DD5,2015-08-24,1.9,
+5DD6,2015-08-24,1.699,
+5DDH,2015-08-24,1.5,
+5DEF,2015-08-25,1.6,
+5DEG,2015-08-25,1.83,
+5DFV,2015-08-27,2.8,
+5DHV,2015-08-31,2.3,
+5DHX,2015-08-31,2.9,
+5DHY,2015-08-31,3.1,
+5DHZ,2015-08-31,4.3,
+5DI8,2015-08-31,1.9,
+5DJ0,2015-09-01,2.28,
+5DJ2,2015-09-01,2.56,
+5DJ6,2015-09-01,2.0,
+5DJ8,2015-09-01,2.4,
+5DJA,2015-09-01,2.9,
+5DJC,2015-09-01,2.1,
+5DJD,2015-09-02,2.3,
+5DJX,2015-09-02,2.25,
+5DJY,2015-09-02,2.15,
+5DJZ,2015-09-02,1.9,
+5DK0,2015-09-02,2.3,
+5DK2,2015-09-02,2.6,
+5DK3,2015-09-02,2.28,
+5DLM,2015-09-07,2.2,
+5DMG,2015-09-08,2.5,
+5DMK,2015-09-08,2.45,
+5DQ9,2015-09-14,1.95,
+5DQD,2015-09-14,1.94,
+5DQJ,2015-09-14,2.61,
+5DR5,2015-09-15,1.85,
+5DRN,2015-09-16,1.994,
+5DRW,2015-09-16,2.27,
+5DRX,2015-09-16,2.104,
+5DRZ,2015-09-16,2.54,
+5DS8,2015-09-17,1.95,
+5DSC,2015-09-17,2.4,
+5DT1,2015-09-17,1.954,
+5DTF,2015-09-18,1.9,
+5DUB,2015-09-18,2.0,
+5DUM,2015-09-19,3.003,
+5DUP,2015-09-20,3.052,
+5DUR,2015-09-20,2.82,
+5DVK,2015-09-21,2.6,
+5DVL,2015-09-21,1.9,
+5DVM,2015-09-21,2.95,
+5DVN,2015-09-21,2.5,
+5DVO,2015-09-21,2.5,
+5DWF,2015-09-22,1.83,
+5DWU,2015-09-23,3.97,
+5DYO,2015-09-25,2.36,
+5DZN,2015-09-25,2.3,
+5DZO,2015-09-25,1.301,
+5E00,2015-09-26,1.7,
+5E0A,2015-09-28,2.6,
+5E0B,2015-09-28,2.6,
+5E2T,2015-10-01,2.1,
+5E2U,2015-10-01,2.4,
+5E2V,2015-10-01,1.64,
+5E2W,2015-10-01,1.5,
+5E56,2015-10-07,1.504,
+5E5M,2015-10-08,2.182,
+5E6I,2015-10-09,4.0,
+5E7B,2015-10-12,1.1,
+5E7W,2015-10-13,0.9519,
+5E8D,2015-10-14,2.5,
+5E8N,2015-10-14,2.25,
+5E8O,2015-10-14,1.98,
+5E8P,2015-10-14,2.0,
+5E99,2015-10-14,2.06,
+5EA0,2015-10-15,2.0,
+5EB9,2015-10-18,2.006,
+5EBG,2015-10-19,1.8,
+5EDX,2015-10-22,1.801,
+5EFI,2015-10-23,1.8,
+5EII,2015-10-29,2.44,
+5EIQ,2015-10-30,2.01,
+5EIV,2015-10-30,2.414,
+5EKI,2015-11-03,1.9,
+5ELI,2015-11-04,3.0977,
+5ENW,2015-11-09,1.85,
+5EO0,2015-11-10,1.7,
+5EO1,2015-11-10,1.85,
+5EOC,2015-11-10,1.98,
+5EOT,2015-11-10,2.1,
+5ESA,2015-11-16,2.6,
+5ESQ,2015-11-16,2.55,
+5ESV,2015-11-17,3.105,
+5ESZ,2015-11-17,4.191,
+5ETU,2015-11-18,2.53,
+5EU3,2015-11-18,1.97,
+5EU4,2015-11-18,2.12,
+5EU5,2015-11-18,1.54,
+5EU6,2015-11-18,2.02,
+5EUK,2015-11-18,2.5,
+5EUO,2015-11-18,2.1,
+5EWI,2015-11-20,1.5996,
+5EZI,2015-11-26,1.61,
+5EZJ,2015-11-26,1.95,
+5EZL,2015-11-26,2.43,
+5EZN,2015-11-26,2.51,
+5EZO,2015-11-26,3.63,
+5F1I,2015-11-30,2.904,
+5F1N,2015-11-30,2.0,
+5F1S,2015-11-30,1.749,
+5F1T,2015-11-30,1.971,
+5F1W,2015-11-30,2.161,
+5F3J,2015-12-02,4.001,
+5F6H,2015-12-06,2.66,
+5F6I,2015-12-06,2.32,
+5F70,2015-12-07,1.8,
+5F71,2015-12-07,2.404,
+5F7D,2015-12-07,2.3,
+5F7E,2015-12-08,1.9,
+5F7F,2015-12-08,1.502,
+5F7H,2015-12-08,2.5,
+5F88,2015-12-09,2.481,
+5F89,2015-12-09,2.7842,
+5F96,2015-12-09,2.2407,
+5F9J,2015-12-09,2.51,
+5F9O,2015-12-10,1.86,
+5F9W,2015-12-10,2.8911,
+5FA2,2015-12-10,2.0,
+5FA3,2015-12-10,1.86,
+5FA4,2015-12-10,2.4,
+5FB8,2015-12-14,2.07,
+5FCS,2015-12-15,2.01,
+5FDW,2015-12-16,2.7,
+5FEC,2015-12-16,3.17,
+5FEH,2015-12-17,3.1,
+5FF6,2015-12-17,2.5,
+5FFL,2015-12-18,1.602,
+5FGB,2015-12-20,1.65,
+5FHA,2015-12-21,1.973,
+5FHB,2015-12-21,1.973,
+5FHX,2015-12-22,2.55,
+5FK9,2015-10-15,3.1,
+5FKA,2015-10-15,2.4,
+5FKP,2015-10-18,1.8,
+5FUC,2016-01-25,2.7,
+5FUO,2016-01-28,3.6,
+5FUZ,2016-02-01,2.68,
+5FV1,2016-02-02,2.7,
+5FWO,2016-02-18,1.7,
+5FXC,2016-02-29,2.05,
+5G4D,2016-05-12,1.701,
+5G64,2016-06-14,3.715,
+5GGQ,2016-06-16,1.9,
+5GGR,2016-06-16,3.3,
+5GGS,2016-06-16,1.997,
+5GGT,2016-06-16,2.8,
+5GGU,2016-06-16,2.292,
+5GGV,2016-06-16,1.998,
+5GHW,2016-06-21,2.4,
+5GIR,2016-06-24,1.93,
+5GIS,2016-06-24,1.93,
+5GIX,2016-06-25,2.801,
+5GJS,2016-07-01,2.9,
+5GJT,2016-07-01,3.1,
+5GJX,2016-07-02,2.06,
+5GJY,2016-07-02,1.71,
+5GKS,2016-07-05,2.05,
+5GMH,2016-07-14,2.2,
+5GPP,2016-08-04,2.0,
+5GPQ,2016-08-04,2.1,
+5GR7,2016-08-08,2.4,
+5GRD,2016-08-10,1.8,
+5GRG,2016-08-11,1.94,
+5GRJ,2016-08-11,3.206,
+5GRM,2016-08-11,1.55,
+5GRU,2016-08-12,1.955,
+5GRV,2016-08-12,2.3,
+5GRW,2016-08-12,2.8,
+5GRX,2016-08-12,2.002,
+5GRY,2016-08-12,1.639,
+5GRZ,2016-08-13,2.7,
+5GS0,2016-08-13,3.275,
+5GS1,2016-08-13,2.0,
+5GS3,2016-08-13,1.698,
+5GS5,2016-08-13,1.84,
+5GSB,2016-08-15,1.801,
+5GSD,2016-08-15,2.3,
+5GSQ,2016-08-17,1.85,
+5GSR,2016-08-17,2.198,
+5GSV,2016-08-17,1.996,
+5GSX,2016-08-17,2.5,
+5GY2,2016-09-21,2.1,
+5GZ0,2016-09-26,1.7,
+5H2B,2016-10-14,2.001,
+5H3C,2016-10-22,2.596,
+5H76,2016-11-17,2.6,
+5H79,2016-11-17,2.7,
+5H7A,2016-11-17,2.7,
+5H7B,2016-11-17,3.1,
+5H8D,2015-12-23,1.89,
+5H8O,2015-12-23,4.206,
+5H94,2015-12-25,1.48,
+5HBA,2015-12-31,2.05,
+5HCC,2016-01-04,2.59,
+5HCD,2016-01-04,2.98,
+5HCE,2016-01-04,3.12,
+5HCG,2016-01-04,2.68,
+5HDA,2016-01-05,2.3899,
+5HDH,2016-01-05,2.6,
+5HDO,2016-01-05,2.16,
+5HGA,2016-01-08,2.199,
+5HGB,2016-01-08,2.4,
+5HGD,2016-01-08,2.07,
+5HGH,2016-01-08,2.392,
+5HHM,2016-01-11,2.5,
+5HHN,2016-01-11,2.03,
+5HHO,2016-01-11,2.95,
+5HHP,2016-01-11,1.9,
+5HHQ,2016-01-11,2.1,
+5HM1,2016-01-15,2.962,
+5HM7,2016-01-15,1.93,
+5HPM,2016-01-20,2.67,
+5HSF,2016-01-25,1.52,
+5HVW,2016-01-28,1.95,
+5HY9,2016-02-01,2.7,
+5HYE,2016-02-01,1.89,
+5HYF,2016-02-01,1.8,
+5HYI,2016-02-01,2.9,
+5HYJ,2016-02-01,3.06,
+5HYP,2016-02-01,3.024,
+5HYQ,2016-02-01,2.477,
+5HYS,2016-02-01,2.5,
+5HYT,2016-02-01,2.54,
+5HYU,2016-02-01,2.561,
+5HZP,2016-02-02,2.74,
+5I0Q,2016-02-04,2.293,
+5I0Z,2016-02-04,1.9,
+5I15,2016-02-05,2.6,
+5I16,2016-02-05,1.9,
+5I17,2016-02-05,3.3,
+5I18,2016-02-05,1.92,
+5I19,2016-02-05,2.8,
+5I1A,2016-02-05,2.0,
+5I1C,2016-02-05,2.25,
+5I1D,2016-02-05,2.0,
+5I1E,2016-02-05,2.7,
+5I1G,2016-02-05,2.3,
+5I1H,2016-02-05,2.222,
+5I1I,2016-02-05,2.5,
+5I1J,2016-02-05,2.5,
+5I1K,2016-02-05,1.65,
+5I1L,2016-02-05,1.95,
+5I2I,2016-02-08,2.551,
+5I30,2016-02-09,1.9,
+5I4D,2016-02-11,1.75,
+5I4F,2016-02-12,1.549,
+5I5K,2016-02-15,4.2,
+5I66,2016-02-16,1.624,
+5I76,2016-02-16,1.922,
+5I8C,2016-02-18,1.54,
+5I8E,2016-02-18,2.655,
+5I8H,2016-02-18,4.301,
+5I8K,2016-02-19,1.771,
+5I8O,2016-02-19,1.8,
+5I9Q,2016-02-20,3.0,
+5IB1,2016-02-22,1.91,
+5IB2,2016-02-22,1.44,
+5IB3,2016-02-22,1.91,
+5IB4,2016-02-22,1.95,
+5IB5,2016-02-22,2.49,
+5IBL,2016-02-22,3.39,
+5IBT,2016-02-22,2.4,
+5IBU,2016-02-22,1.71,
+5ICX,2016-02-23,2.6,
+5ICY,2016-02-23,2.5,
+5ICZ,2016-02-23,2.55,
+5ID0,2016-02-23,2.48,
+5ID1,2016-02-23,2.49,
+5IEH,2016-02-25,1.5,
+5IEK,2016-02-25,1.8,
+5IFA,2016-02-25,1.821,
+5IFH,2016-02-26,2.293,
+5IFJ,2016-02-26,2.35,
+5IG7,2016-02-27,1.97,
+5IGX,2016-02-28,3.39,
+5IHB,2016-02-29,2.24,
+5IHU,2016-02-29,2.06,
+5IHZ,2016-03-01,1.64,
+5IIE,2016-03-01,2.8,
+5IJB,2016-03-01,2.91,
+5IJC,2016-03-01,2.57,
+5IJD,2016-03-01,2.7,
+5IJK,2016-03-02,2.5,
+5IJV,2016-03-02,2.2,
+5IK3,2016-03-03,1.65,
+5ILT,2016-03-04,2.0,
+5IM7,2016-03-05,2.502,
+5IMK,2016-03-06,1.227,
+5IML,2016-03-06,1.8,
+5IMM,2016-03-06,1.2,
+5IMO,2016-03-06,2.1,
+5INC,2016-03-07,2.881,
+5IND,2016-03-07,2.132,
+5IOP,2016-03-08,2.499,
+5IQ7,2016-03-10,3.2869,
+5IQ9,2016-03-10,2.4,
+5IR1,2016-03-11,2.482,
+5IR3,2016-03-11,1.7,
+5IRL,2016-03-14,3.09,
+5IRM,2016-03-14,3.31,
+5IRN,2016-03-14,2.34,
+5ISZ,2016-03-15,2.06,
+5IT2,2016-03-16,1.7,
+5ITB,2016-03-16,2.0,
+5ITF,2016-03-16,2.51,
+5IUS,2016-03-18,2.889,
+5IV2,2016-03-18,2.481,
+5IVX,2016-03-21,2.1,
+5IVZ,2016-03-21,2.48,
+5IW1,2016-03-21,3.001,
+5IW3,2016-03-21,2.05,
+5IW6,2016-03-22,2.34,
+5IXK,2016-03-23,2.35,
+5IZ0,2016-03-24,2.635,
+5J06,2016-03-27,2.66,
+5J0B,2016-03-28,2.48,
+5J13,2016-03-28,2.298,
+5J2S,2016-03-30,2.0,
+5J3D,2016-03-30,4.077,
+5J6G,2016-04-04,3.3,
+5J6H,2016-04-05,2.3,
+5J74,2016-04-05,2.7,
+5J75,2016-04-05,2.0,
+5J89,2016-04-07,2.2,
+5J8O,2016-04-08,2.3,
+5JB2,2016-04-13,2.2,
+5JBG,2016-04-13,2.0,
+5JBJ,2016-04-13,3.58,
+5JC3,2016-04-14,2.6,
+5JC7,2016-04-14,2.75,
+5JCF,2016-04-15,2.6,
+5JCH,2016-04-15,2.95,
+5JDR,2016-04-17,2.7,
+5JDS,2016-04-17,1.7,
+5JEJ,2016-04-18,2.0,
+5JEK,2016-04-18,2.4,
+5JEL,2016-04-18,1.6,
+5JEM,2016-04-18,2.5,
+5JEO,2016-04-18,1.719,
+5JER,2016-04-18,2.913,
+5JHD,2016-04-20,2.46,
+5JIH,2016-04-22,1.663,
+5JII,2016-04-22,1.79,
+5JIK,2016-04-22,1.82,
+5JJO,2016-04-24,2.002,
+5JJX,2016-04-25,2.0,
+5JKP,2016-04-26,2.106,
+5JLZ,2016-04-28,1.99,
+5JMR,2016-04-29,2.27,
+5JNY,2016-05-01,3.041,
+5JO4,2016-05-01,2.53,
+5JO5,2016-05-02,1.7,
+5JOF,2016-05-02,3.208,
+5JOP,2016-05-02,1.75,
+5JOR,2016-05-02,2.206,
+5JPJ,2016-05-03,2.0,
+5JPM,2016-05-03,3.75,
+5JPN,2016-05-03,3.6,
+5JQ6,2016-05-04,2.4,
+5JQD,2016-05-04,2.591,
+5JR1,2016-05-05,1.601,
+5JRP,2016-05-06,2.0,
+5JTW,2016-05-09,3.5,
+5JUE,2016-05-10,1.65,
+5JW3,2016-05-11,3.75,
+5JW4,2016-05-11,3.7,
+5JW5,2016-05-11,1.9,
+5JWD,2016-05-12,2.5,
+5JWE,2016-05-12,2.4,
+5JXA,2016-05-12,1.6,
+5JXD,2016-05-13,2.029,
+5JXE,2016-05-13,2.9,
+5JXV,2016-05-13,,
+5K33,2016-05-19,3.3,
+5K59,2016-05-23,2.84,
+5K64,2016-05-24,2.44,
+5K65,2016-05-24,2.5,
+5K8A,2016-05-27,1.999,
+5K8Y,2016-05-31,2.4,
+5K9J,2016-05-31,1.904,
+5K9K,2016-05-31,2.97,
+5K9O,2016-06-01,3.387,
+5K9Q,2016-06-01,2.503,
+5KAN,2016-06-01,2.785,
+5KAQ,2016-06-01,3.514,
+5KD4,2016-06-07,3.05,
+5KD7,2016-06-07,2.35,
+5KG9,2016-06-13,2.3,
+5KN5,2016-06-27,2.8,
+5KS9,2016-07-08,2.55,
+5KSA,2016-07-08,2.0,
+5KSB,2016-07-08,2.9,
+5KSU,2016-07-10,2.73,
+5KSV,2016-07-10,2.195,
+5KVL,2016-07-14,1.74,
+5KWG,2016-07-18,4.3,
+5KZC,2016-07-24,3.25,
+5L2J,2016-08-02,1.65,
+5L2K,2016-08-02,3.2,
+5L6Q,2016-05-31,1.4,
+5L6Y,2016-06-01,1.99,
+5L7X,2016-06-04,1.86,
+5L83,2016-06-06,1.9,
+5L88,2016-06-07,1.88,
+5L9D,2016-06-10,1.88,
+5LAX,2016-06-15,2.6,
+5LCS,2016-06-22,,
+5LFI,2016-07-01,,
+5LG1,2016-07-05,2.7,
+5LG9,2016-07-06,,
+5LGH,2016-07-07,1.86,
+5LGJ,2016-07-07,2.6,
+5LGK,2016-07-07,3.5,
+5LMJ,2016-08-01,2.1,
+5LMW,2016-08-01,1.5,
+5LVE,1999-02-24,2.0,
+5LY9,2016-09-26,1.65,
+5LZ0,2016-09-29,1.6,
+5M00,2016-10-03,1.95,
+5M01,2016-10-03,1.95,
+5M02,2016-10-03,1.75,
+5M13,2016-10-07,1.372,
+5M14,2016-10-07,1.6,
+5M15,2016-10-07,1.9,
+5M2W,2016-10-13,1.5,
+5M3T,2016-10-17,2.021,
+5M3V,2016-10-17,1.97,
+5M5E,2016-10-21,2.3,
+5M62,2016-10-24,1.7,
+5M63,2016-10-24,2.74,
+5M6A,2016-10-24,1.64,
+5M6I,2016-10-25,2.2,
+5M76,2016-10-26,2.5,
+5M7Q,2016-10-28,1.8,
+5MEN,2016-11-16,2.81,
+5MEO,2016-11-16,1.772,
+5MEP,2016-11-16,2.71,
+5MEQ,2016-11-16,2.27,
+5MER,2016-11-16,1.88,
+5MES,2016-11-16,2.24,
+5MEV,2016-11-16,2.94,
+5MGR,2016-11-22,1.8,
+5MGS,2016-11-22,1.9,
+5MGT,2016-11-22,1.9,
+5MHE,2016-11-24,1.9,
+5MHG,2016-11-24,2.801,
+5MHR,2016-11-25,3.0,
+5MHS,2016-11-25,3.7,
+5MI0,2016-11-27,2.35,
+5MIX,2016-11-29,1.701,
+5MJ0,2016-11-29,3.2,
+5MJ1,2016-11-29,1.8,
+5MJ2,2016-11-29,1.98,
+5MJ3,2016-11-29,1.74,
+5MJ4,2016-11-29,3.4,
+5ML9,2016-12-06,2.35,
+5MN2,2016-12-12,2.35,
+5MO3,2016-12-13,1.69,
+5MO9,2016-12-14,2.594,
+5MOI,2016-12-14,2.2,
+5MOJ,2016-12-14,2.26,
+5MOK,2016-12-14,2.0,
+5MOL,2016-12-14,1.75,
+5MP1,2016-12-15,3.1,
+5MP3,2016-12-15,2.75,
+5MP5,2016-12-15,2.31,
+5MP6,2016-12-15,1.959,
+5MTH,2017-01-09,1.73,
+5MTL,2017-01-10,2.45,
+5MU0,2017-01-11,2.7,
+5MU2,2017-01-12,2.7,
+5MUB,2017-01-13,3.1,
+5MUD,2017-01-13,2.34,
+5MUH,2017-01-13,2.65,
+5MUQ,2017-01-13,2.62,
+5MV3,2017-01-15,2.95,
+5MV4,2017-01-15,2.9,
+5MVG,2017-01-16,2.2,
+5MVJ,2017-01-16,2.5,
+5MX3,2017-01-20,2.98,
+5MY4,2017-01-25,2.211,
+5MYK,2017-01-26,1.6,
+5MYO,2017-01-27,1.59,
+5MYX,2017-01-30,1.492,
+5MZM,2017-02-01,2.4,
+5N1Y,2017-02-06,1.39,
+5N2B,2017-02-07,1.9,
+5N2F,2017-02-07,1.7,
+5N2K,2017-02-07,2.219,
+5N4G,2017-02-10,2.75,
+5N4J,2017-02-10,1.503,
+5N6B,2017-02-14,1.71,
+5N7B,2017-02-20,1.7,
+5N7W,2017-02-21,1.96,
+5N88,2017-02-23,1.7,
+5N92,2017-02-24,2.3,
+5NB5,2017-03-01,3.0,
+5NBI,2017-03-02,2.1,
+5NBQ,2017-03-02,3.18,
+5NBW,2017-03-02,2.4,
+5NH1,2017-03-21,2.04,
+5NHR,2017-03-22,3.35,
+5NHT,2017-03-22,3.2,
+5NHW,2017-03-22,1.78,
+5NI9,2017-03-23,1.33,
+5NIG,2017-03-24,1.35,
+5NIU,2017-03-27,2.01,
+5NIV,2017-03-27,1.498,
+5NJD,2017-03-28,3.9,
+5NLU,2017-04-05,1.193,
+5NLW,2017-04-05,1.5,
+5NM0,2017-04-05,1.5,
+5NMD,2017-04-05,2.07,
+5NME,2017-04-05,2.94,
+5NMF,2017-04-05,2.89,
+5NMG,2017-04-05,2.75,
+5NMH,2017-04-05,1.55,
+5NMK,2017-04-06,1.66,
+5NML,2017-04-06,2.5,
+5NMV,2017-04-07,1.65,
+5NPH,2017-04-16,1.7,
+5NPZ,2017-04-19,1.43,
+5NQ0,2017-04-19,1.1,
+5NQ1,2017-04-19,2.14,
+5NQ2,2017-04-19,1.54,
+5NQ3,2017-04-19,1.57,
+5NQK,2017-04-20,3.25,
+5NQP,2017-04-20,2.86,
+5NQW,2017-04-21,3.4,
+5NQX,2017-04-21,3.66,
+5NQY,2017-04-21,2.6,
+5NQZ,2017-04-21,1.63,
+5NSC,2017-04-26,2.3,
+5NSG,2017-04-26,2.22,
+5NST,2017-04-26,2.52,
+5NUZ,2017-05-03,1.85,
+5NYX,2017-05-12,1.88,
+5O0V,2017-05-17,2.4,
+5O14,2017-05-18,2.195,
+5O1R,2017-05-19,2.86,
+5O32,2017-05-23,4.20620907647,
+5O35,2017-05-23,4.2,
+5O4E,2017-05-29,2.15,
+5O4O,2017-05-30,3.4,
+5O7P,2017-06-09,4.5,
+5O9K,2017-06-19,4.014,
+5O9L,2017-06-19,1.75,
+5O9M,2017-06-19,1.4,
+5OB5,2017-06-26,1.65,
+5OBF,2017-06-26,1.92,
+5OCC,2017-06-30,2.5,
+5OCK,2017-07-03,1.6,
+5OCL,2017-07-03,2.2,
+5OCX,2017-07-04,1.75,
+5OCY,2017-07-04,2.6,
+5OD0,2017-07-04,1.8,
+5OD8,2017-07-05,2.2,
+5ODB,2017-07-05,1.53,
+5OPI,2017-08-09,3.3,
+5OPY,2017-08-10,2.26,
+5OQF,2017-08-11,2.27,
+5OQG,2017-08-11,1.9,
+5OQH,2017-08-11,2.05,
+5OQI,2017-08-11,2.4,
+5OTJ,2017-08-22,2.35,
+5OWP,2017-09-02,1.85,
+5R5T,2020-02-28,1.55,
+5R5U,2020-02-28,1.52,
+5R5V,2020-02-28,1.7,
+5R5W,2020-02-28,1.6,
+5R5X,2020-02-28,1.56,
+5R5Y,2020-02-28,1.57,
+5R5Z,2020-02-28,1.67,
+5R60,2020-02-28,1.79,
+5R61,2020-02-28,1.38,
+5R62,2020-02-28,1.4,
+5R63,2020-02-28,1.59,
+5SWQ,2016-08-08,2.0,
+5SWS,2016-08-08,2.86,
+5SWZ,2016-08-09,2.65,
+5SY8,2016-08-10,1.62,
+5SZF,2016-08-13,2.52,
+5T08,2016-08-15,2.1895,
+5T0B,2016-08-15,2.001,
+5T0D,2016-08-15,2.864,
+5T0E,2016-08-15,2.089,
+5T0Y,2016-08-17,3.011,
+5T1K,2016-08-19,2.48,
+5T1L,2016-08-19,2.48,
+5T1M,2016-08-19,2.53,
+5T29,2016-08-23,2.03,
+5T2Q,2016-08-24,1.9,
+5T2R,2016-08-24,2.1,
+5T33,2016-08-24,3.2092,
+5T3S,2016-08-26,4.5,
+5T44,2016-08-29,1.9944,
+5T4Z,2016-08-30,1.991,
+5T5B,2016-08-30,2.07,
+5T6L,2016-09-01,2.1,
+5T6P,2016-09-01,1.97,
+5T6W,2016-09-01,1.9,
+5T6X,2016-09-02,1.686,
+5T6Y,2016-09-02,1.76,
+5T6Z,2016-09-02,2.0,
+5T70,2016-09-02,2.1,
+5T78,2016-09-02,2.2,
+5T7G,2016-09-04,1.961,
+5T80,2016-09-06,2.62,
+5T85,2016-09-06,2.373,
+5T93,2016-09-09,1.9,
+5TBD,2016-09-12,2.2,
+5TDN,2016-09-19,1.63,
+5TDO,2016-09-19,1.61,
+5TDP,2016-09-19,1.716,
+5TE4,2016-09-20,2.75,
+5TE6,2016-09-20,2.4,
+5TE7,2016-09-20,2.15,
+5TEC,2016-09-20,2.2,
+5TEZ,2016-09-23,1.7,
+5TF1,2016-09-23,1.858,
+5TFS,2016-09-26,2.319,
+5TFW,2016-09-26,2.168,
+5TGB,2016-09-27,2.741,
+5TH2,2016-09-28,1.84,
+5TIH,2016-10-03,2.44,
+5TIK,2016-10-03,3.09,
+5TIL,2016-10-03,2.83,
+5TJD,2016-10-04,2.1,
+5TJE,2016-10-04,3.2,
+5TKJ,2016-10-06,2.118,
+5TKK,2016-10-06,1.55,
+5TL5,2016-10-10,1.8,
+5TLJ,2016-10-11,3.5,
+5TLK,2016-10-11,2.7,
+5TP3,2016-10-19,1.874,
+5TPL,2016-10-20,2.5,
+5TPN,2016-10-20,3.141,
+5TPP,2016-10-20,1.85,
+5TPS,2016-10-21,2.7,
+5TQA,2016-10-23,2.723,
+5TR8,2016-10-25,2.01,
+5TRP,2016-10-27,2.692,
+5TRU,2016-10-27,3.0,
+5TRZ,2016-10-27,2.247,
+5TS1,2016-10-27,2.3,
+5TXS,2016-11-17,1.697,
+5TY6,2016-11-18,1.361,
+5TZ2,2016-11-21,2.302,
+5TZT,2016-11-22,2.89,
+5TZU,2016-11-22,2.1,
+5U07,2016-11-23,3.8,
+5U0A,2016-11-23,3.3,
+5U0R,2016-11-26,3.295,
+5U0U,2016-11-27,3.428,
+5U15,2016-11-27,2.26,
+5U16,2016-11-27,2.0,
+5U17,2016-11-28,2.15,
+5U1R,2016-11-28,2.7,
+5U2V,2016-12-01,2.2,
+5U3D,2016-12-01,1.77,
+5U3P,2016-12-02,1.5,
+5U4R,2016-12-05,1.762,
+5U52,2016-12-06,1.942,
+5U5F,2016-12-06,1.81,
+5U5M,2016-12-06,1.88,
+5U64,2016-12-07,1.153,
+5U65,2016-12-07,2.3,
+5U6A,2016-12-07,1.736,
+5U6Q,2016-12-08,1.9,
+5U72,2016-12-10,2.5,
+5U98,2016-12-15,2.0,
+5UBX,2016-12-21,2.7,
+5UBY,2016-12-21,2.6,
+5UBZ,2016-12-21,2.75,
+5UCB,2016-12-22,1.521,
+5UD8,2016-12-23,1.8,
+5UD9,2016-12-23,1.3,
+5UEA,2016-12-29,1.701,
+5UEI,2017-01-02,1.702,
+5UEK,2017-01-02,1.7,
+5UEL,2017-01-02,1.6,
+5UEM,2017-01-02,2.7,
+5UF1,2017-01-03,2.03,
+5UF4,2017-01-03,2.04,
+5UFB,2017-01-04,1.844,
+5UFC,2017-01-04,1.888,
+5UFD,2017-01-04,1.696,
+5UFF,2017-01-04,2.137,
+5UIX,2017-01-15,2.501,
+5UJT,2017-01-18,1.94,
+5UKN,2017-01-23,1.75,
+5UKO,2017-01-23,2.3,
+5UKP,2017-01-23,2.0,
+5UKQ,2017-01-23,2.1,
+5UKR,2017-01-23,2.712,
+5UMN,2017-01-27,1.97,
+5UR7,2017-02-09,2.0004,
+5UR8,2017-02-09,1.75500231418,
+5URV,2017-02-13,2.2,
+5UTF,2017-02-14,3.503,
+5UUI,2017-02-16,1.4,
+5UXQ,2017-02-23,2.415,
+5UY3,2017-02-23,2.9,
+5UZB,2017-02-25,7.0,
+5V43,2017-03-08,2.32,
+5V4E,2017-03-09,3.216,
+5V4M,2017-03-10,2.1,
+5V4N,2017-03-10,3.405,
+5V52,2017-03-13,3.1,
+5V5L,2017-03-14,2.002,
+5V5M,2017-03-14,2.878,
+5V7R,2017-03-20,2.3,
+5V7U,2017-03-20,1.64,
+5VAA,2017-03-24,1.55,
+5VAG,2017-03-26,1.9,
+5VCJ,2017-03-31,3.16,
+5VCL,2017-03-31,2.05,
+5VCN,2017-03-31,3.0,
+5VCO,2017-03-31,2.74,
+5VEB,2017-04-04,2.34,
+5VF2,2017-04-06,1.55,
+5VF6,2017-04-06,1.635,
+5VGA,2017-04-10,2.5,
+5VGD,2017-04-11,2.32,
+5VGE,2017-04-11,2.6,
+5VGP,2017-04-11,2.116,
+5VH3,2017-04-12,2.0,
+5VH4,2017-04-12,2.0,
+5VH5,2017-04-12,1.75,
+5VIC,2017-04-14,3.0,
+5VIG,2017-04-16,3.0,
+5VKD,2017-04-21,1.749,
+5VKJ,2017-04-21,2.12,
+5VKK,2017-04-21,2.014,
+5VKM,2017-04-21,2.2,
+5VL3,2017-04-24,3.1,
+5VME,2017-04-27,3.1,
+5VN3,2017-04-28,3.7,
+5VN8,2017-04-28,3.6,
+5VR9,2017-05-10,2.15,
+5VSH,2017-05-11,2.55,
+5VSI,2017-05-11,1.51,
+5VU0,2017-05-18,2.26,
+5VUD,2017-05-19,2.0,
+5VUE,2017-05-19,1.8,
+5VUF,2017-05-19,1.9,
+5VVF,2017-05-19,2.0,
+5VVP,2017-05-19,2.0,
+5VWD,2017-05-21,1.8,
+5VWF,2017-05-21,1.8,
+5VWH,2017-05-21,1.648,
+5VWJ,2017-05-22,2.0,
+5VXJ,2017-05-23,2.5,
+5VXK,2017-05-23,2.55,
+5VXL,2017-05-23,2.8,
+5VXM,2017-05-23,2.05,
+5VXR,2017-05-24,1.4,
+5VYF,2017-05-25,2.9,
+5VZ1,2017-05-26,2.112,
+5VZ5,2017-05-26,2.5901,
+5VZR,2017-05-29,1.57,
+5VZX,2017-05-29,2.501,
+5VZY,2017-05-29,2.32,
+5W05,2017-05-30,1.64,
+5W06,2017-05-30,2.6,
+5W1G,2017-06-03,2.0,
+5W1V,2017-06-04,3.31,
+5W1W,2017-06-05,3.1,
+5W24,2017-06-05,1.5,
+5W38,2017-06-07,1.8,
+5W3P,2017-06-08,1.92,
+5W42,2017-06-08,3.569,
+5W5L,2017-06-15,1.9,
+5W5M,2017-06-15,1.9,
+5W5N,2017-06-15,1.85,
+5W67,2017-06-16,2.3,
+5W69,2017-06-16,2.8,
+5W6A,2017-06-16,1.74,
+5W6C,2017-06-16,1.634,
+5WAV,2017-06-27,2.6,
+5WAW,2017-06-27,2.25,
+5WCA,2017-06-29,1.369,
+5WCC,2017-06-29,2.461,
+5WCD,2017-06-29,1.814,
+5WDF,2017-07-05,3.1,
+5WDU,2017-07-06,7.0,
+5WEQ,2017-07-10,2.0,
+5WER,2017-07-10,3.412,
+5WES,2017-07-10,2.706,
+5WET,2017-07-10,2.64,
+5WEU,2017-07-10,1.584,
+5WHJ,2017-07-17,2.15,
+5WHK,2017-07-17,2.5,
+5WHZ,2017-07-18,3.549,
+5WI8,2017-07-18,2.95,
+5WIW,2017-07-20,2.3,
+5WJF,2017-07-21,2.6,
+5WJL,2017-07-23,3.15,
+5WJN,2017-07-23,2.85,
+5WJO,2017-07-24,2.5,
+5WK2,2017-07-24,1.5,
+5WK3,2017-07-24,1.9,
+5WK4,2017-07-24,1.498,
+5WKE,2017-07-25,1.69,
+5WKF,2017-07-25,2.95,
+5WKG,2017-07-25,2.06,
+5WKH,2017-07-25,3.2,
+5WKI,2017-07-25,2.75,
+5WKZ,2017-07-25,1.85,
+5WL1,2017-07-25,1.38,
+5WLG,2017-07-26,2.1,
+5WLI,2017-07-27,2.2,
+5WMN,2017-07-30,1.82,
+5WMO,2017-07-30,1.62,
+5WMP,2017-07-30,1.6,
+5WMQ,2017-07-31,1.4,
+5WMR,2017-07-31,1.58,
+5WSH,2016-12-07,2.0,
+5WT9,2016-12-10,2.401,
+5WTG,2016-12-11,2.907,
+5WUV,2016-12-21,1.952,
+5WUX,2016-12-21,2.9,
+5WWI,2017-01-01,3.194,
+5WWJ,2017-01-01,2.29,
+5WWU,2017-01-05,2.794,
+5WXC,2017-01-07,2.295,
+5WXD,2017-01-07,3.295,
+5WYM,2017-01-13,2.65,
+5WYX,2017-01-16,2.4,
+5WYZ,2017-01-16,2.3,
+5X08,2017-01-20,1.49,
+5X0T,2017-01-23,2.5,
+5X4G,2017-02-13,1.45,
+5X5X,2017-02-18,1.9,
+5X8L,2017-03-03,3.1,
+5X8M,2017-03-03,2.661,
+5XAJ,2017-03-13,2.5,
+5XCQ,2017-03-23,1.313,
+5XCR,2017-03-23,1.75,
+5XCS,2017-03-23,2.2,
+5XCT,2017-03-23,1.17,
+5XCU,2017-03-23,2.454,
+5XCV,2017-03-23,2.143,
+5XCX,2017-03-23,2.04,
+5XF0,2017-04-06,,
+5XGY,2017-04-18,2.45,
+5XHB,2017-04-20,1.9,
+5XHF,2017-04-20,3.205,
+5XHG,2017-04-20,1.76,
+5XJ3,2017-04-29,3.2,
+5XJ4,2017-04-29,2.3,
+5XJE,2017-05-01,2.4,
+5XJF,2017-05-01,2.5,
+5XKU,2017-05-09,1.78,
+5XLI,2017-05-10,1.696,
+5XMF,2017-05-15,2.1,
+5XMG,2017-05-15,2.8,
+5XMH,2017-05-15,2.8,
+5XMM,2017-05-15,2.9,
+5XO2,2017-05-25,2.201,
+5XOF,2017-05-28,1.963,
+5XOS,2017-05-31,1.697,
+5XOT,2017-05-31,2.787,
+5XOV,2017-05-31,2.684,
+5XP1,2017-05-31,2.88,
+5XPV,2017-06-05,1.9,
+5XPW,2017-06-05,2.003,
+5XQW,2017-06-07,2.2,
+5XQY,2017-06-07,2.9,
+5XRQ,2017-06-09,2.6,
+5XS3,2017-06-12,2.5,
+5XVN,2017-06-28,3.25,
+5XVO,2017-06-28,3.1,
+5XVP,2017-06-28,3.0,
+5XXY,2017-07-05,2.9,
+5XZ3,2017-07-11,1.86,
+5XZ4,2017-07-11,1.41,
+5Y2K,2017-07-26,2.1,
+5Y2M,2017-07-26,3.8,
+5Y3J,2017-07-29,1.81,
+5Y3K,2017-07-29,2.7,
+5Y3L,2017-07-29,2.6,
+5Y3M,2017-07-29,2.5,
+5Y3S,2017-07-30,2.451,
+5Y56,2017-08-07,2.653,
+5Y91,2017-08-22,1.901,
+5YAX,2017-09-02,2.5,
+5YC5,2017-09-06,2.71,
+5YD3,2017-09-11,1.35,
+5YD4,2017-09-11,1.35,
+5YD5,2017-09-11,1.96,
+5YFI,2017-09-21,1.848,
+5YLX,2017-10-20,2.2,
+5YMV,2017-10-22,2.197,
+5YMW,2017-10-22,1.997,
+5YOY,2017-10-31,2.727,
+5YSL,2017-11-14,2.5,
+5YUD,2017-11-21,4.28,
+5YUP,2017-11-22,1.81,
+5YWF,2017-11-29,2.206,
+5YWP,2017-11-29,4.6,
+5YXK,2017-12-05,1.9,
+5YXN,2017-12-06,2.03,
+5YXU,2017-12-07,2.7,
+5YY4,2017-12-07,1.59,
+5YZP,2017-12-15,1.581,
+5YZW,2017-12-15,2.001,
+5Z11,2017-12-22,2.35,
+5Z14,2017-12-25,2.8,
+5Z15,2017-12-25,2.9,
+5Z2C,2018-01-02,2.594,
+5Z4B,2018-01-10,,
+5Z7D,2018-01-28,4.5,
+5Z7Q,2018-01-30,1.85,
+5ZIA,2018-03-14,2.603,
+5ZLN,2018-03-28,2.3,
+5ZMJ,2018-04-04,1.81,
+5ZNG,2018-04-09,2.189,
+5ZSA,2018-04-28,2.5,
+5ZSB,2018-04-28,2.7,
+5ZSC,2018-04-28,2.2,
+5ZSD,2018-04-28,2.603,
+5ZSE,2018-04-28,2.201,
+5ZSF,2018-04-28,2.1,
+5ZSG,2018-04-28,2.3,
+5ZSH,2018-04-28,2.6,
+5ZSI,2018-04-28,2.7,
+5ZSJ,2018-04-28,2.4,
+5ZSL,2018-04-28,2.3,
+5ZSM,2018-04-28,2.5,
+5ZSN,2018-04-28,2.4,
+5ZV3,2018-05-09,2.093,
+6A0X,2018-06-06,2.3,
+6A2B,2018-06-10,2.8,
+6A3V,2018-06-17,3.391,
+6A3W,2018-06-17,2.0,
+6A67,2018-06-26,2.33,
+6A6H,2018-06-28,2.31,
+6A76,2018-07-02,1.5,
+6A77,2018-07-02,2.0,
+6A78,2018-07-02,2.1,
+6A79,2018-07-02,2.31,
+6A89,2018-07-06,2.11,
+6A97,2018-07-11,2.148,
+6A9K,2018-07-13,1.9,
+6AED,2018-08-04,3.797,
+6AEE,2018-08-04,3.303,
+6AL4,2017-08-07,2.45,
+6AL5,2017-08-07,3.0,
+6AM5,2017-08-09,2.394,
+6AMJ,2017-08-09,2.49,
+6AMM,2017-08-10,2.8,
+6AMT,2017-08-11,2.496,
+6AMU,2017-08-11,2.151,
+6ANA,2017-08-12,1.7,
+6AND,2017-08-12,1.75,
+6ANI,2017-08-13,2.4,
+6ANP,2017-08-14,2.45,
+6ANV,2017-08-14,2.265,
+6ANW,2017-08-14,2.486,
+6AO0,2017-08-15,2.35,
+6AO3,2017-08-15,1.76,
+6AO4,2017-08-15,2.901,
+6APB,2017-08-17,3.0,
+6APC,2017-08-17,1.7,
+6APD,2017-08-17,4.1,
+6APN,2017-08-17,2.22,
+6APO,2017-08-17,1.168,
+6APP,2017-08-17,1.75,
+6APQ,2017-08-17,1.9,
+6AQ7,2017-08-18,1.83,
+6ARP,2017-08-23,1.7,
+6ARQ,2017-08-23,2.88,
+6AT5,2017-08-27,1.5,
+6AT6,2017-08-28,1.417,
+6AT9,2017-08-28,2.9503,
+6ATF,2017-08-29,1.9,
+6ATG,2017-08-29,1.8,
+6ATI,2017-08-29,1.98,
+6ATT,2017-08-29,3.77,
+6ATZ,2017-08-29,2.7,
+6AU5,2017-08-30,2.484,
+6AVF,2017-09-02,2.028,
+6AVG,2017-09-02,2.6,
+6AVN,2017-09-03,2.5,
+6AXK,2017-09-07,2.103,
+6AXL,2017-09-07,2.4,
+6AXP,2017-09-07,2.484,
+6AYN,2017-09-08,2.48,
+6AYZ,2017-09-08,2.096,
+6AZ2,2017-09-09,2.477,
+6AZK,2017-09-11,2.477,
+6AZL,2017-09-11,2.482,
+6AZM,2017-09-11,1.6,
+6AZX,2017-09-13,2.1,
+6AZZ,2017-09-13,2.4,
+6B08,2017-09-14,2.2,
+6B0A,2017-09-14,2.5,
+6B0E,2017-09-14,3.3,
+6B0G,2017-09-14,1.9,
+6B0H,2017-09-14,2.7,
+6B0S,2017-09-15,1.95,
+6B0W,2017-09-15,1.9,
+6B3D,2017-09-21,2.271,
+6B5B,2017-09-29,5.2,
+6B5L,2017-09-29,2.4,
+6B5M,2017-09-29,1.79,
+6B5N,2017-09-29,1.98,
+6B5O,2017-09-29,2.194,
+6B5P,2017-09-29,2.297,
+6B5R,2017-09-29,1.775,
+6B5S,2017-09-29,1.983,
+6B5T,2017-09-29,2.222,
+6B6Z,2017-10-03,2.112,
+6B9Y,2017-10-11,2.14,
+6B9Z,2017-10-11,1.82,
+6BA5,2017-10-12,1.62,
+6BAE,2017-10-12,2.14,
+6BAH,2017-10-12,1.9,
+6BAN,2017-10-14,1.95,
+6BB4,2017-10-16,2.099,
+6BCS,2017-10-20,2.1,
+6BE2,2017-10-24,1.7,
+6BE3,2017-10-24,1.6,
+6BE4,2017-10-24,1.9,
+6BFQ,2017-10-26,2.6,
+6BFS,2017-10-26,2.0,
+6BFT,2017-10-27,2.55,
+6BGA,2017-10-27,2.307,
+6BHQ,2017-10-31,2.05,
+6BHY,2017-10-31,2.04,
+6BHZ,2017-10-31,1.75,
+6BI0,2017-10-31,2.057,
+6BI2,2017-10-31,1.801,
+6BIJ,2017-11-02,2.1,
+6BIL,2017-11-02,2.4,
+6BIN,2017-11-02,2.50000845062,
+6BIR,2017-11-02,2.3,
+6BIT,2017-11-03,2.191,
+6BIV,2017-11-03,2.9,
+6BIX,2017-11-03,2.2,
+6BIY,2017-11-03,2.05004900063,
+6BIZ,2017-11-03,2.1,
+6BJ2,2017-11-03,3.35,
+6BJ3,2017-11-03,1.898,
+6BJ8,2017-11-05,1.75,
+6BJZ,2017-11-07,1.45,
+6BKB,2017-11-08,2.799,
+6BKC,2017-11-08,2.6,
+6BKD,2017-11-08,3.25,
+6BLA,2017-11-09,1.55,
+6BLQ,2017-11-11,1.8,
+6BLR,2017-11-11,1.96,
+6BLX,2017-11-11,2.323,
+6BMH,2017-11-14,2.298,
+6BMK,2017-11-15,2.43,
+6BNK,2017-11-16,3.2,
+6BNL,2017-11-16,2.6,
+6BPB,2017-11-22,1.87,
+6BPD,2017-11-22,2.32,
+6BQB,2017-11-27,1.769,
+6BWV,2017-12-15,2.4,
+6BXA,2017-12-18,2.298,
+6BXC,2017-12-18,2.5,
+6BXD,2017-12-18,1.103,
+6BXE,2017-12-18,1.651,
+6BXP,2017-12-18,1.45,
+6BXQ,2017-12-18,1.58,
+6BZ4,2017-12-22,2.4,
+6BZU,2017-12-26,2.7,
+6BZV,2017-12-26,2.654,
+6BZW,2017-12-26,2.2,
+6BZY,2017-12-26,1.6,
+6C09,2017-12-28,2.95,
+6C15,2018-01-03,3.21,
+6C5M,2018-01-16,2.45,
+6C61,2018-01-17,2.43,
+6C68,2018-01-18,2.59,
+6C69,2018-01-18,1.937,
+6C6A,2018-01-18,2.45,
+6C6C,2018-01-18,2.08,
+6C6E,2018-01-18,2.18,
+6C6F,2018-01-18,1.67,
+6C6H,2018-01-18,2.0,
+6C6J,2018-01-18,1.79,
+6C6X,2018-01-19,1.99,
+6C6Y,2018-01-19,3.32,
+6C6Z,2018-01-19,2.1,
+6C80,2018-01-23,1.78,
+6C97,2018-01-25,2.0,
+6C98,2018-01-25,1.85,
+6C99,2018-01-25,2.0,
+6C9O,2018-01-28,1.2,
+6CA6,2018-01-29,2.43,
+6CA7,2018-01-29,1.643,
+6CA9,2018-01-29,2.702,
+6CB8,2018-02-02,3.8,
+6CBJ,2018-02-03,2.85,
+6CBP,2018-02-03,2.17,
+6CBV,2018-02-05,1.872,
+6CDM,2018-02-08,2.408,
+6CDO,2018-02-08,2.099,
+6CDP,2018-02-08,2.456,
+6CEZ,2018-02-13,2.399,
+6CFF,2018-02-14,2.396,
+6CH7,2018-02-22,3.8,
+6CH8,2018-02-22,4.1,
+6CH9,2018-02-22,4.85,
+6CHB,2018-02-22,6.801,
+6CHE,2018-02-22,1.1,
+6CHF,2018-02-22,2.4,
+6CJC,2018-02-26,2.575,
+6CJK,2018-02-26,1.795,
+6CJX,2018-02-27,2.44,
+6CK8,2018-02-27,2.05,
+6CKH,2018-02-28,2.1,
+6CNE,2018-03-08,1.2,
+6CNR,2018-03-08,2.09,
+6CNW,2018-03-09,0.92,
+6CO3,2018-03-10,2.384,
+6CPH,2018-03-13,1.7,
+6CPL,2018-03-13,2.45,
+6CPN,2018-03-13,2.0,
+6CPO,2018-03-13,2.4,
+6CPZ,2018-03-14,1.12,
+6CQJ,2018-03-15,2.75,
+6CQL,2018-03-15,2.4,
+6CQN,2018-03-15,2.5,
+6CQQ,2018-03-16,2.8,
+6CQR,2018-03-16,3.04,
+6CR1,2018-03-16,1.521,
+6CT7,2018-03-22,1.903,
+6CTE,2018-03-22,1.2,
+6CUG,2018-03-26,2.4,
+6CUH,2018-03-26,2.01,
+6CW6,2018-03-29,2.85,
+6CW9,2018-03-30,2.0,
+6CWB,2018-03-30,2.85,
+6CWE,2018-03-30,2.2,
+6CWG,2018-03-30,2.6,
+6CWK,2018-03-30,1.256,
+6CX5,2018-04-02,2.4,
+6CX7,2018-04-02,2.6,
+6CX9,2018-04-02,2.36,
+6CXA,2018-04-02,2.65,
+6CXE,2018-04-02,2.05,
+6CXF,2018-04-02,2.5,
+6CXG,2018-04-03,2.298,
+6CXL,2018-04-03,3.586,
+6CXO,2018-04-03,2.2,
+6CY7,2018-04-04,2.2,
+6CYF,2018-04-05,2.78,
+6CYW,2018-04-06,1.95,
+6D01,2018-04-09,3.2,
+6D0X,2018-04-11,1.849,
+6D11,2018-04-11,3.4,
+6D29,2018-04-13,1.88,
+6D2B,2018-04-13,2.04,
+6D2P,2018-04-13,2.6,
+6D2R,2018-04-13,1.83,
+6D2T,2018-04-13,1.9,
+6D48,2018-04-17,1.776,
+6D49,2018-04-17,1.801,
+6D4A,2018-04-17,1.751,
+6D4E,2018-04-18,2.8,
+6D4I,2018-04-18,2.95,
+6D4M,2018-04-18,3.47,
+6D4N,2018-04-18,3.25,
+6D58,2018-04-19,2.39,
+6D64,2018-04-20,1.7,
+6D78,2018-04-24,2.347,
+6D7G,2018-04-24,2.75,
+6D9G,2018-04-29,2.3,
+6DB5,2018-05-02,2.599,
+6DB6,2018-05-02,1.978,
+6DB7,2018-05-02,2.213,
+6DBA,2018-05-02,1.3,
+6DBD,2018-05-03,1.755,
+6DBE,2018-05-03,1.65,
+6DBF,2018-05-03,1.55,
+6DBG,2018-05-03,1.51,
+6DC3,2018-05-04,3.501,
+6DC4,2018-05-04,1.7,
+6DC5,2018-05-04,3.5,
+6DC7,2018-05-04,1.901,
+6DC8,2018-05-04,1.799,
+6DC9,2018-05-04,2.999,
+6DCA,2018-05-04,2.599,
+6DCV,2018-05-08,1.9,
+6DCW,2018-05-08,2.0,
+6DDM,2018-05-10,1.3,
+6DDR,2018-05-10,1.9,
+6DDV,2018-05-10,2.05,
+6DE7,2018-05-11,4.123,
+6DEZ,2018-05-13,3.2,
+6DF0,2018-05-13,2.3,
+6DF1,2018-05-13,2.3,
+6DF2,2018-05-13,2.6,
+6DFI,2018-05-14,2.48,
+6DFJ,2018-05-14,2.07,
+6DFQ,2018-05-15,2.6,
+6DFS,2018-05-15,3.1,
+6DFV,2018-05-15,1.71,
+6DFW,2018-05-15,3.2,
+6DFX,2018-05-15,2.03,
+6DG2,2018-05-16,1.96,
+6DHB,2018-05-19,1.7,
+6DIG,2018-05-23,2.0,
+6DKP,2018-05-30,2.966,
+6DL8,2018-05-31,3.805,
+6DLA,2018-05-31,2.004,
+6DLB,2018-05-31,2.2,
+6DLW,2018-06-03,3.9,
+6DN0,2018-06-05,2.0,
+6DNK,2018-06-06,1.95,
+6DRI,2018-06-11,,
+6DSI,2018-06-14,2.49,
+6DW2,2018-06-26,1.7,
+6DWA,2018-06-26,1.922,
+6DWC,2018-06-26,2.27,
+6DWI,2018-06-26,2.39,
+6DYX,2018-07-02,1.5,
+6DZN,2018-07-05,2.1,
+6DZR,2018-07-05,2.4,
+6E1I,2018-07-09,1.99,
+6E4Y,2018-07-18,2.24,
+6E4Z,2018-07-18,2.202,
+6E62,2018-07-23,2.7,
+6E63,2018-07-23,2.6,
+6E64,2018-07-23,3.15,
+6E65,2018-07-23,1.5,
+6E7D,2018-07-26,2.9,
+6E8V,2018-07-31,3.79,
+6E9G,2018-08-01,2.904,
+6E9H,2018-08-01,2.0,
+6E9I,2018-08-01,2.5,
+6E9K,2018-08-01,2.193,
+6E9Q,2018-08-01,3.4,
+6E9U,2018-08-01,2.295,
+6EAQ,2018-08-03,2.22,
+6EDU,2018-08-11,4.06,
+6EH4,2017-09-12,1.26,
+6EH5,2017-09-12,1.29,
+6EH6,2017-09-12,1.78,
+6EH7,2017-09-12,1.89,
+6EH8,2017-09-12,2.51,
+6EH9,2017-09-12,2.49,
+6EHG,2017-09-13,2.65,
+6EHV,2017-09-15,2.54,
+6EHW,2017-09-15,2.19,
+6EHX,2017-09-15,2.2,
+6EHY,2017-09-15,2.25,
+6EI2,2017-09-16,1.61,
+6ELC,2017-09-28,1.41,
+6ELE,2017-09-28,1.78,
+6ELJ,2017-09-29,1.9,
+6ELL,2017-09-29,1.9,
+6EMJ,2017-10-02,2.3,
+6ENY,2017-10-07,5.8,
+6EQA,2017-10-12,3.16,
+6EQB,2017-10-12,2.81,
+6ERE,2017-10-18,2.25,
+6EV1,2017-11-01,3.043,
+6EV2,2017-11-01,2.403,
+6EWA,2017-11-03,2.39,
+6EWC,2017-11-03,3.2,
+6EWO,2017-11-06,2.3,
+6EYN,2017-11-13,2.4,
+6EYO,2017-11-13,3.7,
+6EZW,2017-11-16,1.59842847381,
+6F03,2017-11-17,2.2,
+6F0D,2017-11-19,1.90000753152,
+6F1E,2017-11-21,2.296,
+6F2Z,2017-11-27,2.3,
+6F7T,2017-12-11,2.6,
+6FAX,2017-12-18,2.99,
+6FCZ,2017-12-21,10.0,
+6FG1,2018-01-09,2.03,
+6FG2,2018-01-09,2.788,
+6FGB,2018-01-10,2.9,
+6FGM,2018-01-11,,
+6FGO,2018-01-11,2.5,
+6FL0,2018-01-25,2.9,
+6FMH,2018-01-31,2.8,
+6FOE,2018-02-07,2.6,
+6FPV,2018-02-12,1.64,
+6FR3,2018-02-15,1.35,
+6FR4,2018-02-15,1.28,
+6FR5,2018-02-15,1.37,
+6FR6,2018-02-15,2.98,
+6FR7,2018-02-15,2.31,
+6FR8,2018-02-15,2.38,
+6FR9,2018-02-15,1.62,
+6FRA,2018-02-15,1.73,
+6FRB,2018-02-15,1.75,
+6FRC,2018-02-15,1.59,
+6FRJ,2018-02-16,1.4,
+6FS1,2018-02-18,1.6,
+6FS2,2018-02-18,2.55,
+6FUM,2018-02-27,1.76,
+6FUN,2018-02-27,1.58,
+6FUO,2018-02-27,1.7,
+6FUP,2018-02-27,1.72,
+6FUQ,2018-02-27,1.6,
+6FUR,2018-02-27,1.73,
+6FXN,2018-03-09,2.9,
+6FY0,2018-03-10,2.57,
+6FY1,2018-03-10,3.132,
+6FY2,2018-03-10,2.301,
+6FY3,2018-03-10,2.6,
+6FZQ,2018-03-15,1.7,
+6FZR,2018-03-15,1.8,
+6G19,2018-03-20,3.68,
+6G1E,2018-03-21,1.88,
+6G1S,2018-03-21,3.93,
+6G1X,2018-03-22,3.93,
+6G3J,2018-03-26,2.45,
+6G3K,2018-03-26,2.9,
+6G9Q,2018-04-11,1.89,
+6G9R,2018-04-11,2.7,
+6GB5,2018-04-13,2.3,
+6GB6,2018-04-13,1.78,
+6GB7,2018-04-13,2.15,
+6GC2,2018-04-17,2.55,
+6GF2,2018-04-29,,
+6GFE,2018-04-30,1.8,
+6GFF,2018-04-30,3.1,
+6GGM,2018-05-03,2.734,
+6GH1,2018-05-04,2.1,
+6GH4,2018-05-04,2.16,
+6GHG,2018-05-07,1.88,
+6GHN,2018-05-08,2.542,
+6GJS,2018-05-16,1.95,
+6GJZ,2018-05-17,4.06,
+6GK2,2018-05-18,4.9,
+6GK7,2018-05-18,2.95,
+6GK8,2018-05-18,2.85,
+6GKH,2018-05-21,4.06,
+6GKM,2018-05-21,3.87,
+6GL1,2018-05-22,2.623,
+6GL3,2018-05-22,2.77,
+6GQ4,2018-06-07,1.65,
+6GRQ,2018-06-12,3.3,
+6GRS,2018-06-12,3.4,
+6GRT,2018-06-12,4.504,
+6GRZ,2018-06-13,2.1,
+6GZP,2018-07-04,2.1,
+6H03,2018-07-06,5.6,
+6H04,2018-07-06,5.6,
+6H06,2018-07-06,2.63,
+6H0E,2018-07-09,1.95,
+6H2Y,2018-07-17,2.65,
+6H3H,2018-07-18,1.92,
+6H4K,2018-07-21,2.05,
+6H61,2018-07-25,4.02,
+6H66,2018-07-26,4.16,
+6H6A,2018-07-26,2.0,
+6H6D,2018-07-27,2.4,
+6H6H,2018-07-27,2.4,
+6H7J,2018-07-31,2.8,
+6H7L,2018-07-31,2.7,
+6H7M,2018-07-31,2.76,
+6H7N,2018-07-31,2.5,
+6HBY,2018-08-13,1.95,
+6HG4,2018-08-22,3.32,
+6HG9,2018-08-23,3.62,
+6HGA,2018-08-23,2.6,
+6HGO,2018-08-23,2.1,
+6HGU,2018-08-23,1.5,
+6HIG,2018-08-29,2.2,
+6HKG,2018-09-06,1.87,
+6HXU,2018-10-18,1.19,
+6HXW,2018-10-18,2.78,
+6HYG,2018-10-21,2.31,
+6I04,2018-10-25,3.1,
+6I07,2018-10-25,2.35,
+6I8C,2018-11-20,1.92,
+6I8G,2018-11-20,2.344,
+6I8H,2018-11-20,3.682,
+6IAP,2018-11-27,2.9,
+6IAS,2018-11-27,1.75,
+6IBL,2018-11-30,2.7,
+6ID4,2018-09-08,2.4,
+6IDG,2018-09-10,2.0,
+6IDH,2018-09-10,2.5,
+6IDM,2018-09-10,3.2,
+6IEX,2018-09-17,2.314,
+6IF5,2018-09-18,2.0,
+6IFJ,2018-09-20,2.4,
+6IGU,2018-09-26,2.11,
+6II4,2018-10-03,3.3,
+6II8,2018-10-03,3.32,
+6II9,2018-10-03,3.5,
+6ILC,2018-10-17,2.2,
+6ILE,2018-10-17,2.9,
+6ILF,2018-10-17,2.7,
+6ILG,2018-10-18,2.6,
+6INN,2018-10-26,3.001,
+6INO,2018-10-26,3.054,
+6INU,2018-10-27,2.65,
+6INV,2018-10-27,3.3,
+6IOE,2018-10-30,2.9,
+6ION,2018-10-30,2.75,
+6IQG,2018-11-08,2.998,
+6IQH,2018-11-08,2.999,
+6IRL,2018-11-13,2.1,
+6ISA,2018-11-16,2.0,
+6ISB,2018-11-16,2.5,
+6ISC,2018-11-16,2.2,
+6ITP,2018-11-24,1.572,
+6ITQ,2018-11-24,1.526,
+6IUF,2018-11-28,2.052,
+6IUT,2018-11-30,2.3,
+6IUV,2018-11-30,2.332,
+6IWG,2018-12-05,1.8,
+6IWH,2018-12-05,1.95,
+6IZB,2018-12-19,1.899,
+6IZE,2018-12-19,2.29,
+6J14,2018-12-27,1.4,
+6J15,2018-12-27,2.6,
+6J1V,2018-12-29,2.0,
+6J1W,2018-12-29,1.501,
+6J29,2018-12-31,1.6,
+6J2A,2018-12-31,1.4,
+6J2D,2019-01-01,2.313,
+6J2E,2019-01-01,2.1,
+6J2F,2019-01-01,1.9,
+6J2G,2019-01-01,2.41,
+6J2H,2019-01-01,2.3,
+6J2I,2019-01-01,2.3,
+6J2J,2019-01-01,2.5,
+6J4I,2019-01-09,,
+6J7W,2019-01-18,2.6,
+6J8L,2019-01-19,2.3,
+6JB9,2019-01-25,1.15,
+6JBT,2019-01-26,2.47,
+6JC2,2019-01-27,2.65,
+6JJP,2019-02-26,2.9,
+6JLI,2019-03-06,1.778,
+6JOZ,2019-03-25,1.35,
+6JP3,2019-03-25,1.66,
+6JQ2,2019-03-28,2.4,
+6JQ3,2019-03-28,2.5,
+6JTN,2019-04-11,1.9,
+6JTO,2019-04-11,1.7,
+6JTP,2019-04-11,1.9,
+6JU0,2019-04-12,2.601,
+6JV7,2019-04-16,1.309,
+6JV8,2019-04-16,1.582,
+6JWC,2019-04-19,2.297,
+6JXR,2019-04-24,3.7,
+6K0Y,2019-05-08,1.7,
+6K4Z,2019-05-27,1.65,
+6K60,2019-05-31,3.149,
+6K7O,2019-06-08,3.004,
+6K7T,2019-06-08,1.6,
+6K7U,2019-06-08,1.601,
+6KA7,2019-06-21,3.0,
+6KDH,2019-07-02,2.47,
+6KDI,2019-07-02,2.7,
+6KI0,2019-07-16,2.0,
+6KIR,2019-07-19,1.55,
+6KIS,2019-07-19,1.54,
+6KIT,2019-07-19,1.57,
+6KMC,2019-07-31,1.84,
+6KMT,2019-08-01,2.6,
+6KMU,2019-08-01,2.1,
+6KMV,2019-08-01,3.35,
+6KMZ,2019-08-01,3.61,
+6KN0,2019-08-02,2.793,
+6KN1,2019-08-02,1.9,
+6KR0,2019-08-20,2.3,
+6KRU,2019-08-22,2.3,
+6KRV,2019-08-22,3.3,
+6KS2,2019-08-23,1.753,
+6KVA,2019-09-03,2.2,
+6KVF,2019-09-04,2.79,
+6KVM,2019-09-04,1.897,
+6KX0,2019-09-09,2.404,
+6KX1,2019-09-09,1.773,
+6KX9,2019-09-10,2.902,
+6KXG,2019-09-11,2.805,
+6KXS,2019-09-12,3.4,
+6KYA,2019-09-17,2.89,
+6KYV,2019-09-20,3.0,
+6L7Z,2019-11-03,,
+6L8T,2019-11-07,1.766,
+6L91,2019-11-07,1.842,
+6L98,2019-11-08,1.77,
+6L9B,2019-11-08,1.95,
+6L9D,2019-11-08,1.73,
+6L9K,2019-11-10,1.8,
+6L9L,2019-11-10,2.399,
+6L9M,2019-11-10,2.6,
+6L9N,2019-11-10,2.6,
+6LAH,2019-11-12,1.87,
+6LAM,2019-11-12,1.8,
+6LB2,2019-11-13,1.69380954073,
+6LBE,2019-11-14,2.6,
+6LCS,2019-11-19,2.6,
+6LDV,2019-11-23,1.9,
+6LDW,2019-11-23,1.6,
+6LDX,2019-11-23,1.8,
+6LDY,2019-11-23,1.77,
+6LFV,2019-12-03,1.9,
+6LFW,2019-12-03,1.41,
+6LFX,2019-12-03,1.43,
+6LHF,2019-12-08,2.7,
+6LHG,2019-12-08,2.8,
+6LHH,2019-12-08,2.71,
+6LIR,2019-12-12,2.091,
+6LJI,2019-12-16,1.843,
+6LKT,2019-12-20,1.8,
+6LNB,2019-12-28,3.18,
+6LNC,2019-12-28,3.21,
+6LRA,2020-01-15,1.9,
+6LT6,2020-01-21,2.15,
+6LTG,2020-01-22,1.63,
+6LUO,2020-01-30,2.302,
+6LUP,2020-01-30,2.302,
+6LVX,2020-02-06,2.77,
+6LVY,2020-02-06,2.6,
+6LVZ,2020-02-06,2.83,
+6LW0,2020-02-06,2.6,
+6LW1,2020-02-06,2.8,
+6LWT,2020-02-08,1.9,
+6LX3,2020-02-10,3.15,
+6LXW,2020-02-12,3.27,
+6LZ4,2020-02-18,2.49,
+6LZ9,2020-02-18,2.8,
+6M1B,2020-02-25,1.88,
+6M24,2020-02-26,2.29,
+6M2J,2020-02-27,2.2,
+6M2K,2020-02-27,2.59,
+6M58,2020-03-10,2.95,
+6M87,2018-08-21,2.609,
+6MB2,2018-08-29,5.0,
+6MB3,2018-08-29,3.37,
+6MED,2018-09-06,2.04,
+6MEE,2018-09-06,1.36,
+6MEF,2018-09-06,2.9,
+6MEG,2018-09-06,1.41,
+6MEH,2018-09-06,1.99,
+6MEI,2018-09-06,2.9,
+6MEJ,2018-09-06,2.8,
+6MEK,2018-09-06,3.1,
+6MF8,2018-09-10,,
+6MFF,2018-09-10,2.6,
+6MFG,2018-09-10,2.0,
+6MFJ,2018-09-11,2.62,
+6MG4,2018-09-12,1.75,
+6MG5,2018-09-12,1.8,
+6MGE,2018-09-13,2.95,
+6MGP,2018-09-14,2.13,
+6MH2,2018-09-17,2.8,
+6MHG,2018-09-17,3.57,
+6MHR,2018-09-18,2.8,
+6MI2,2018-09-19,2.72,
+6MIV,2018-09-20,2.05,
+6MIY,2018-09-20,2.75,
+6MJ3,2018-09-20,3.8,
+6MJ4,2018-09-20,2.0,
+6MJ6,2018-09-20,2.45,
+6MJA,2018-09-20,2.35,
+6MJI,2018-09-20,2.3,
+6MJJ,2018-09-21,1.93,
+6MJO,2018-09-21,1.9,
+6MKD,2018-09-25,3.2,
+6MKR,2018-09-26,3.355,
+6MNF,2018-10-01,2.758,
+6MNG,2018-10-01,2.662,
+6MNM,2018-10-02,3.1,
+6MNN,2018-10-02,2.83,
+6MNO,2018-10-02,2.9,
+6MNQ,2018-10-02,1.804,
+6MNR,2018-10-02,2.201,
+6MNS,2018-10-02,2.7,
+6MP0,2018-10-05,2.0,
+6MP1,2018-10-05,2.211,
+6MPP,2018-10-08,,
+6MQC,2018-10-09,1.99,
+6MQE,2018-10-09,2.459,
+6MQM,2018-10-10,3.484,
+6MQR,2018-10-10,2.45,
+6MQS,2018-10-10,2.997,
+6MRA,2018-10-12,1.7,
+6MSS,2018-10-18,3.0,
+6MSY,2018-10-18,1.999,
+6MT3,2018-10-19,1.21,
+6MT4,2018-10-19,1.55,
+6MT5,2018-10-19,1.55,
+6MT6,2018-10-19,1.31,
+6MTL,2018-10-19,1.35,
+6MTM,2018-10-19,3.0,
+6MTO,2018-10-21,2.634,
+6MTP,2018-10-21,2.036,
+6MTQ,2018-10-21,2.7,
+6MTR,2018-10-21,1.798,
+6MTS,2018-10-21,2.437,
+6MTT,2018-10-21,1.7,
+6MTX,2018-10-22,2.051,
+6MTY,2018-10-22,2.951,
+6MU3,2018-10-22,2.327,
+6MUA,2018-10-22,2.91,
+6MUB,2018-10-22,2.503,
+6MV5,2018-10-24,2.1,
+6MVL,2018-10-26,1.61,
+6MWR,2018-10-30,3.3,
+6MX0,2018-10-30,1.73,
+6MX3,2018-10-30,1.362,
+6MXR,2018-10-31,2.04,
+6MXS,2018-10-31,1.95,
+6MY4,2018-11-01,1.69,
+6MY5,2018-11-01,1.73,
+6MYD,2018-11-01,1.399,
+6N16,2018-11-08,2.302,
+6N2U,2018-11-14,1.254,
+6N2X,2018-11-14,3.0,
+6N32,2018-11-14,2.2,
+6N35,2018-11-14,1.747,
+6N77,2018-11-27,1.64,
+6N78,2018-11-27,1.83,
+6N79,2018-11-27,2.27,
+6N7A,2018-11-27,1.33,
+6N7B,2018-11-27,1.81,
+6N7C,2018-11-27,1.69,
+6N7D,2018-11-27,1.78,
+6N7U,2018-11-28,2.03,
+6N81,2018-11-28,2.579,
+6N8D,2018-11-29,3.1,
+6N9N,2018-12-03,3.3,
+6N9O,2018-12-03,3.5,
+6N9P,2018-12-03,2.23,
+6N9T,2018-12-04,2.576,
+6NB5,2018-12-06,3.0,
+6NB8,2018-12-06,1.5,
+6NC2,2018-12-10,5.2,
+6NC3,2018-12-10,4.5,
+6NCA,2018-12-11,3.30000082539,
+6NCP,2018-12-11,2.76,
+6NEX,2018-12-18,2.15,
+6NF2,2018-12-18,3.7,
+6NF7,2018-12-19,2.9,
+6NFN,2018-12-20,2.63,
+6NG3,2018-12-21,2.88,
+6NG9,2018-12-21,1.954,
+6NGG,2018-12-21,1.95,
+6NHA,2018-12-21,2.381,
+6NHW,2018-12-24,,
+6NHY,2018-12-24,,
+6NIH,2018-12-27,2.3,
+6NIJ,2018-12-29,5.7,
+6NIS,2018-12-31,2.113,
+6NIX,2019-01-01,2.1,
+6NM6,2019-01-10,2.739,
+6NMR,2019-01-11,2.42,
+6NMS,2019-01-11,2.11,
+6NMT,2019-01-11,1.83,
+6NMU,2019-01-11,2.55,
+6NMV,2019-01-11,2.61,
+6NNF,2019-01-14,2.762,
+6NNJ,2019-01-15,2.6,
+6NNV,2019-01-15,1.92,
+6NOJ,2019-01-16,2.33,
+6NOS,2019-01-16,2.701,
+6NOU,2019-01-16,1.914,
+6NOV,2019-01-16,2.14,
+6NP9,2019-01-17,1.27,
+6NPR,2019-01-18,2.37,
+6NPY,2019-01-18,3.8,
+6NRY,2019-01-24,2.184,
+6NS7,2019-01-24,2.4,
+6NT5,2019-01-28,4.1,
+6NT6,2019-01-28,4.0,
+6NT7,2019-01-28,4.0,
+6NT8,2019-01-28,6.5,
+6NT9,2019-01-28,3.3,
+6NUX,2019-02-03,2.2,
+6NYH,2019-02-11,2.1,
+6NYQ,2019-02-12,1.85,
+6NZ7,2019-02-13,2.95,
+6O23,2019-02-22,2.0,
+6O24,2019-02-22,1.4,
+6O25,2019-02-22,2.9,
+6O26,2019-02-22,1.8,
+6O28,2019-02-22,1.93,
+6O29,2019-02-22,2.4,
+6O2A,2019-02-22,2.15,
+6O2B,2019-02-22,2.1,
+6O2C,2019-02-22,2.017,
+6O3D,2019-02-26,1.402,
+6O3G,2019-02-26,3.645,
+6O3J,2019-02-26,3.416,
+6O3K,2019-02-26,1.451,
+6O3L,2019-02-26,1.98,
+6O3O,2019-02-27,2.8,
+6O3U,2019-02-27,3.105,
+6O41,2019-02-27,2.465,
+6O42,2019-02-27,2.6,
+6O4Y,2019-03-01,1.58,
+6O4Z,2019-03-01,1.5,
+6O51,2019-03-01,1.55,
+6O53,2019-03-01,1.4,
+6O6S,2019-03-07,2.65,
+6O6T,2019-03-07,2.31,
+6O6Y,2019-03-07,1.96,
+6O6Z,2019-03-07,2.1,
+6O70,2019-03-07,2.3,
+6O73,2019-03-07,3.0,
+6O74,2019-03-07,2.71,
+6O7D,2019-03-07,2.81,
+6O89,2019-03-09,2.09,
+6O8B,2019-03-09,3.4,
+6O8C,2019-03-09,3.17,
+6O8D,2019-03-09,3.547,
+6O94,2019-03-13,1.98,
+6O95,2019-03-13,1.77,
+6O9B,2019-03-13,2.2,
+6O9C,2019-03-13,2.45,
+6O9D,2019-03-13,2.51,
+6O9H,2019-03-13,2.1,
+6O9I,2019-03-13,2.6,
+6OAW,2019-03-18,2.2,
+6OBD,2019-03-20,2.2,
+6OBZ,2019-03-21,1.73,
+6OC3,2019-03-21,2.85,
+6OC7,2019-03-22,1.296,
+6OC8,2019-03-22,2.109,
+6OCB,2019-03-22,2.1,
+6OE9,2019-03-27,1.94,
+6OED,2019-03-27,2.461,
+6OEJ,2019-03-27,3.45,
+6OEL,2019-03-27,3.1,
+6OFI,2019-03-29,3.85,
+6OGX,2019-04-03,2.77,
+6OHG,2019-04-05,2.385,
+6OJP,2019-04-11,2.17,
+6OKM,2019-04-14,2.1,
+6OKN,2019-04-14,3.25,
+6OKQ,2019-04-14,3.2,
+6OL5,2019-04-15,2.9,
+6OL6,2019-04-15,2.6,
+6OL7,2019-04-15,2.419,
+6OM1,2019-04-17,2.66,
+6OM2,2019-04-17,2.77,
+6OMG,2019-04-18,2.1,
+6OO0,2019-04-22,2.1,
+6OOR,2019-04-23,2.45,
+6OPA,2019-04-24,4.084,
+6OPD,2019-04-24,1.791,
+6OSH,2019-05-01,1.117,
+6OSN,2019-05-01,1.083,
+6OSY,2019-05-02,4.3,
+6OT1,2019-05-02,3.5,
+6OVN,2019-05-08,1.77,
+6OVO,2019-05-08,2.49,
+6OZ2,2019-05-15,2.55,
+6OZ3,2019-05-15,3.15,
+6OZ4,2019-05-15,4.05,
+6P23,2019-05-20,1.595,
+6P27,2019-05-21,1.593,
+6P2C,2019-05-21,1.396,
+6P2F,2019-05-21,1.482,
+6P2S,2019-05-22,1.65,
+6P3B,2019-05-23,2.02,
+6P4C,2019-05-27,1.85,
+6P4Y,2019-05-29,1.799,
+6P50,2019-05-29,2.9,
+6P60,2019-05-31,2.498,
+6P64,2019-05-31,3.05,
+6P67,2019-06-03,2.9,
+6P6D,2019-06-03,2.31,
+6P79,2019-06-05,1.583,
+6P7H,2019-06-05,1.782,
+6P8D,2019-06-07,2.102,
+6P8M,2019-06-07,3.594,
+6P8N,2019-06-07,3.202,
+6P9H,2019-06-10,3.003,
+6P9I,2019-06-10,2.4,
+6P9J,2019-06-10,2.2,
+6P9N,2019-06-10,2.65,
+6PA1,2019-06-11,3.01,
+6PAG,2019-06-11,2.501,
+6PBH,2019-06-13,1.89,
+6PBV,2019-06-14,1.566,
+6PBW,2019-06-14,2.058,
+6PDR,2019-06-19,1.555,
+6PDS,2019-06-19,1.893,
+6PDU,2019-06-19,1.953,
+6PDX,2019-06-19,3.993,
+6PE7,2019-06-20,1.74,
+6PE8,2019-06-20,2.84,
+6PE9,2019-06-20,3.13,
+6PEC,2019-06-20,1.746,
+6PEF,2019-06-20,2.004,
+6PEH,2019-06-20,2.296,
+6PHB,2019-06-25,2.0,
+6PHC,2019-06-25,2.9,
+6PHD,2019-06-25,3.1,
+6PHF,2019-06-25,3.1,
+6PHG,2019-06-25,2.0,
+6PHH,2019-06-25,2.4,
+6PIL,2019-06-26,2.2,
+6PK8,2019-06-28,2.91,
+6PLH,2019-06-30,1.6,
+6POO,2019-07-04,3.03,
+6PSC,2019-07-12,3.6,
+6PTB,2019-07-15,2.15,
+6PTE,2019-07-15,1.901,
+6PUC,2019-07-18,1.85,
+6PUD,2019-07-18,1.8,
+6PUE,2019-07-18,1.9,
+6PUF,2019-07-18,1.92,
+6PUG,2019-07-18,1.8,
+6PUH,2019-07-18,1.88,
+6PUI,2019-07-18,1.96,
+6PUJ,2019-07-18,1.92,
+6PUK,2019-07-18,2.08,
+6PUL,2019-07-18,1.84,
+6PUM,2019-07-18,1.96,
+6PV9,2019-07-19,2.0,
+6PVC,2019-07-20,1.96,
+6PVD,2019-07-20,2.14,
+6PX6,2019-07-24,3.00000337881,
+6PXG,2019-07-26,2.1,
+6PXR,2019-07-26,1.556,
+6PY2,2019-07-28,2.82543430029,
+6PYC,2019-07-29,3.6,
+6PYD,2019-07-29,2.0,
+6PYJ,2019-07-30,1.44,
+6PYL,2019-07-30,1.52,
+6PYV,2019-07-31,1.45,
+6PYW,2019-07-31,1.38,
+6PZ5,2019-07-31,1.53,
+6PZE,2019-07-31,2.3,
+6PZF,2019-07-31,2.8,
+6PZG,2019-07-31,1.59,
+6PZH,2019-07-31,2.3,
+6PZP,2019-08-01,1.94,
+6Q0E,2019-08-01,2.15,
+6Q0H,2019-08-01,2.75,
+6Q0I,2019-08-01,2.702,
+6Q0L,2019-08-01,2.5,
+6Q0O,2019-08-02,3.0,
+6Q0S,2019-08-02,1.94,
+6Q18,2019-08-03,2.55,
+6Q19,2019-08-03,1.58,
+6Q1A,2019-08-03,2.001,
+6Q1E,2019-08-03,2.5,
+6Q1G,2019-08-04,1.75,
+6Q1J,2019-08-05,2.703,
+6Q1K,2019-08-05,2.2,
+6Q2P,2019-08-08,1.452,
+6Q2Q,2019-08-08,1.892,
+6Q3K,2018-12-04,1.5,
+6Q3S,2018-12-04,2.5,
+6Q6Z,2018-12-12,3.476,
+6QAX,2018-12-19,,
+6QB0,2018-12-20,,
+6QB1,2018-12-20,,
+6QCU,2018-12-31,1.56,
+6QJB,2019-01-24,,
+6QKD,2019-01-29,1.9,
+6QN7,2019-02-10,2.15,
+6QN8,2019-02-10,2.12,
+6QN9,2019-02-10,1.89,
+6QNA,2019-02-10,2.62,
+6QNK,2019-02-11,1.9,
+6QNV,2019-02-12,1.4,
+6QRN,2019-02-19,1.4,
+6QZA,2019-03-11,3.09,
+6QZC,2019-03-11,1.64,
+6QZD,2019-03-11,2.66,
+6R0E,2019-03-12,1.91,
+6R1H,2019-03-14,1.55,
+6R2L,2019-03-18,2.3,
+6R2S,2019-03-18,3.04,
+6R3K,2019-03-20,2.2,
+6R7T,2019-03-29,2.682,
+6RBB,2019-04-10,2.45,
+6RCO,2019-04-11,1.66,
+6RCQ,2019-04-11,2.28,
+6RCS,2019-04-11,2.1,
+6RLM,2019-05-02,2.5,
+6RLO,2019-05-02,2.2,
+6RLR,2019-05-02,2.0,
+6RMT,2019-05-07,2.0,
+6RMU,2019-05-07,2.4,
+6RNN,2019-05-09,1.95,
+6RP8,2019-05-14,2.6,
+6RP9,2019-05-14,3.12,
+6RPA,2019-05-14,2.56,
+6RPB,2019-05-14,2.5,
+6RPJ,2019-05-14,3.25,
+6RQM,2019-05-16,3.0,
+6RSR,2019-05-22,3.15,
+6RST,2019-05-22,3.29,
+6RSU,2019-05-22,2.75,
+6RSY,2019-05-22,2.95,
+6RU3,2019-05-27,1.26,
+6RU5,2019-05-27,3.9,
+6RUR,2019-05-29,6.0,
+6RUS,2019-05-29,2.8,
+6RUV,2019-05-29,6.15,
+6RV6,2019-05-31,3.507,
+6RYG,2019-06-10,0.974,
+6RYJ,2019-06-10,1.25,
+6RYM,2019-06-10,1.46,
+6RYN,2019-06-10,1.0,
+6S08,2019-06-14,2.03,
+6S0A,2019-06-14,2.52,
+6S0B,2019-06-14,2.312,
+6S5A,2019-07-01,1.72,
+6SA4,2019-07-16,1.77,
+6SA5,2019-07-16,1.29,
+6SAN,2019-07-17,1.36,
+6SEJ,2019-07-30,3.501,
+6SF6,2019-08-01,1.9,
+6SGE,2019-08-04,1.5,
+6SHG,2019-08-06,3.35050823996,
+6SM1,2019-08-21,1.55,
+6SNC,2019-08-23,3.2,
+6SND,2019-08-23,3.1,
+6SNE,2019-08-23,3.9,
+6SNY,2019-08-27,3.11,
+6SRU,2019-09-06,2.532,
+6SS7,2019-09-06,2.5,
+6SS8,2019-09-06,2.24,
+6SS9,2019-09-06,2.7,
+6SSA,2019-09-06,2.11,
+6ST4,2019-09-10,1.29,
+6STC,2019-09-10,1.69,
+6STE,2019-09-10,1.79,
+6STK,2019-09-10,1.52,
+6SXI,2019-09-26,1.85,
+6T2J,2019-10-08,1.7,
+6T3Y,2019-10-11,1.7,
+6T8X,2019-10-25,2.81,
+6T9D,2019-10-28,2.905,
+6T9E,2019-10-28,2.989,
+6TCM,2019-11-06,1.85,
+6TCN,2019-11-06,2.3,
+6TCO,2019-11-06,1.8,
+6TCP,2019-11-06,2.5,
+6TCQ,2019-11-06,2.05,
+6TCR,2019-11-06,1.45,
+6TCS,2019-11-06,2.3,
+6TDO,2019-11-09,1.65,
+6TDP,2019-11-10,1.4,
+6TDQ,2019-11-10,1.6,
+6TDR,2019-11-10,1.75,
+6TDS,2019-11-10,1.7,
+6THH,2019-11-20,3.48,
+6TKB,2019-11-28,2.0,
+6TKC,2019-11-28,2.3,
+6TKD,2019-11-28,1.9,
+6TKE,2019-11-28,2.35,
+6TKF,2019-11-28,2.18,
+6TMO,2019-12-05,2.1,
+6TNP,2019-12-09,3.0,
+6TRN,2019-12-19,1.35,
+6TRO,2019-12-19,3.0,
+6TXZ,2020-01-15,3.06,
+6TY5,2020-01-15,2.793,
+6TYB,2019-08-08,2.301,
+6U07,2019-08-13,1.76,
+6U12,2019-08-15,1.56,
+6U14,2019-08-15,1.3,
+6U1T,2019-08-16,1.483,
+6U23,2019-08-19,3.49,
+6U2J,2019-08-20,2.37,
+6U2K,2019-08-20,2.93,
+6U2L,2019-08-20,2.83,
+6U2W,2019-08-20,3.63,
+6U3M,2019-08-22,1.9,
+6U3N,2019-08-22,2.8,
+6U3O,2019-08-22,2.743,
+6U3Z,2019-08-22,1.99002311102,
+6U50,2019-08-26,1.6,
+6U51,2019-08-26,2.52,
+6U52,2019-08-26,1.9,
+6U53,2019-08-26,1.49,
+6U54,2019-08-26,1.6,
+6U55,2019-08-26,1.93,
+6U6M,2019-08-30,2.683,
+6U6O,2019-08-30,2.806,
+6U6V,2019-08-30,1.9,
+6U85,2019-09-04,2.78,
+6U8C,2019-09-04,2.61,
+6U9U,2019-09-09,2.26,
+6UC5,2019-09-13,1.75,
+6UE7,2019-09-20,2.9,
+6UE8,2019-09-20,3.0,
+6UE9,2019-09-20,2.9,
+6UEA,2019-09-20,3.0,
+6UG7,2019-09-26,1.52,
+6UG8,2019-09-26,1.89,
+6UG9,2019-09-26,2.74,
+6UGA,2019-09-26,2.5,
+6UGS,2019-09-26,1.95,
+6UGT,2019-09-26,2.15,
+6UGU,2019-09-26,2.2,
+6UGV,2019-09-26,2.4,
+6UGW,2019-09-26,2.0,
+6UGX,2019-09-26,2.1,
+6UGY,2019-09-26,2.1,
+6UJ7,2019-10-02,1.9,
+6UJ8,2019-10-02,2.25,
+6UJ9,2019-10-02,2.9,
+6UJO,2019-10-03,2.25,
+6UJQ,2019-10-03,2.55,
+6UK2,2019-10-04,3.13880812156,
+6UK4,2019-10-04,2.7,
+6UKM,2019-10-05,1.74,
+6UKU,2019-10-06,1.68,
+6UKV,2019-10-06,1.83,
+6UKW,2019-10-06,1.97,
+6UKX,2019-10-06,1.93,
+6UKY,2019-10-06,1.95,
+6UKZ,2019-10-06,1.52,
+6UL0,2019-10-06,1.76,
+6ULE,2019-10-07,2.55,
+6ULF,2019-10-07,1.7,
+6ULI,2019-10-08,1.88,
+6ULK,2019-10-08,1.9,
+6ULN,2019-10-08,2.01,
+6ULR,2019-10-08,3.2,
+6UMH,2019-10-09,2.15,
+6UMI,2019-10-09,2.4,
+6UMJ,2019-10-09,2.7,
+6UMT,2019-10-10,1.986,
+6UMU,2019-10-10,1.183,
+6UMV,2019-10-10,1.424,
+6UON,2019-10-15,3.5,
+6UQC,2019-10-18,1.87,
+6UQR,2019-10-21,3.65029109708,
+6USW,2019-10-28,2.5,
+6UT1,2019-10-29,2.65,
+6UTB,2019-10-29,2.5,
+6UTD,2019-10-29,2.2,
+6UUD,2019-10-30,1.85,
+6UUH,2019-10-30,2.7,
+6UUL,2019-10-30,2.06,
+6UUM,2019-10-30,2.1,
+6UYG,2019-11-13,3.375,
+6UZ1,2019-11-14,3.14,
+6UZM,2019-11-15,1.798,
+6UZN,2019-11-15,2.22,
+6UZO,2019-11-15,2.349,
+6UZP,2019-11-15,2.08,
+6UZQ,2019-11-15,2.395,
+6UZS,2019-11-15,1.9,
+6V0Y,2019-11-19,2.7,
+6V13,2019-11-19,2.75,
+6V15,2019-11-19,2.8,
+6V18,2019-11-20,2.35,
+6V19,2019-11-20,2.6,
+6V1A,2019-11-20,2.29,
+6V2O,2019-11-25,1.27,
+6V2P,2019-11-25,1.3,
+6V2Q,2019-11-25,1.6,
+6V3J,2019-11-25,1.98,
+6V4Q,2019-11-28,1.39,
+6V4R,2019-11-28,3.48,
+6V7Y,2019-12-10,2.4,
+6V7Z,2019-12-10,2.75,
+6V80,2019-12-10,3.53,
+6V9P,2019-12-14,1.93,
+6V9Q,2019-12-15,2.9,
+6VB0,2019-12-18,1.9,
+6VB1,2019-12-18,1.75,
+6VB2,2019-12-18,1.41,
+6VB3,2019-12-18,2.0,
+6VB4,2019-12-18,2.334,
+6VB5,2019-12-18,2.15,
+6VB6,2019-12-18,2.15,
+6VB7,2019-12-18,2.1,
+6VBW,2019-12-19,3.2,
+6VC9,2019-12-20,2.25,
+6VCA,2019-12-20,3.73,
+6VHI,2020-01-09,2.46,
+6VI0,2020-01-10,3.43,
+6VI1,2020-01-11,2.4,
+6VI2,2020-01-11,1.15,
+6VIE,2020-01-13,3.4,
+6VIH,2020-01-13,2.993,
+6VII,2020-01-13,2.0,
+6VIJ,2020-01-13,1.95,
+6VIK,2020-01-13,1.7,
+6VIU,2020-01-14,2.334,
+6VJA,2020-01-15,3.3,
+6VJB,2020-01-15,2.24,
+6VJN,2020-01-16,2.0,
+6VL8,2020-01-23,2.42,
+6VL9,2020-01-23,2.63,
+6VLN,2020-01-24,1.63,
+6VM7,2020-01-27,2.41,
+6VM8,2020-01-27,2.41,
+6VM9,2020-01-27,2.9,
+6VMA,2020-01-27,2.75,
+6VMC,2020-01-27,2.85,
+6VMX,2020-01-28,3.1,
+6VO3,2020-01-29,4.25,
+6VOR,2020-01-31,1.85,
+6VOS,2020-01-31,2.299,
+6VOV,2020-01-31,1.95,
+6VPY,2020-02-04,2.36,
+6VPZ,2020-02-04,2.1,
+6VQ2,2020-02-04,2.25,
+6VQD,2020-02-05,1.88,
+6VQE,2020-02-05,1.77,
+6VQO,2020-02-05,3.0,
+6VQY,2020-02-06,2.57,
+6VQZ,2020-02-06,2.25,
+6VR1,2020-02-06,2.37,
+6VR5,2020-02-06,2.38,
+6VRB,2020-02-07,3.0,
+6VRC,2020-02-07,3.2,
+6VRM,2020-02-08,2.61,
+6VRN,2020-02-08,2.46,
+6VRQ,2020-02-08,2.57,
+6VRT,2020-02-09,2.555,
+6VRW,2020-02-10,3.71,
+6VRY,2020-02-10,1.4,
+6VSL,2020-02-11,2.1,
+6VSR,2020-02-11,2.176,
+6VSZ,2020-02-12,2.6,
+6VTC,2020-02-12,1.83,
+6VTH,2020-02-12,2.36,
+6VTU,2020-02-13,2.61,
+6VTW,2020-02-13,2.6,
+6VU2,2020-02-14,2.19,
+6VY2,2020-02-25,4.86,
+6W00,2020-02-28,1.853,
+6W05,2020-02-29,2.516,
+6W16,2020-03-03,3.1,
+6W4V,2020-03-11,2.1,
+6W4W,2020-03-11,1.77,
+6W4Y,2020-03-11,1.91,
+6W51,2020-03-12,3.53,
+6W5A,2020-03-12,1.75,
+6W5D,2020-03-13,2.0,
+6W73,2020-03-18,2.8,
+6W7Y,2020-03-19,3.3,
+6W9G,2020-03-23,1.82,
+6W9U,2020-03-23,1.89,
+6W9V,2020-03-23,1.95,
+6WAS,2020-03-26,1.904,
+6WCZ,2020-03-31,4.0,
+6WFW,2020-04-04,2.093,
+6WFX,2020-04-04,2.59,
+6WFY,2020-04-04,1.226,
+6WFZ,2020-04-04,1.84,
+6WG0,2020-04-04,1.599,
+6WG1,2020-04-04,2.086,
+6WG2,2020-04-04,2.534,
+6WG8,2020-04-05,1.36,
+6WGB,2020-04-05,1.99,
+6WGJ,2020-04-05,1.9,
+6WGK,2020-04-05,1.62,
+6WGL,2020-04-05,2.82,
+6WIB,2020-04-09,2.55,
+6WIY,2020-04-11,1.65,
+6WIZ,2020-04-11,4.2,
+6WJ0,2020-04-11,1.802,
+6WJ1,2020-04-11,3.503,
+6WJU,2020-04-14,3.1,
+6WK4,2020-04-15,2.1,
+6WKL,2020-04-16,1.89,
+6WKM,2020-04-16,2.1,
+6WL2,2020-04-18,3.3,
+6WL3,2020-04-18,3.45,
+6WL4,2020-04-18,3.6,
+6WLA,2020-04-18,2.6,
+6WMH,2020-04-21,2.3,
+6WML,2020-04-21,2.5,
+6WMW,2020-04-21,2.91,
+6WN4,2020-04-22,2.8,
+6WNA,2020-04-22,2.4,
+6WO4,2020-04-24,2.349,
+6WOL,2020-04-24,2.49,
+6WOR,2020-04-25,2.601,
+6WOS,2020-04-25,1.645,
+6WPP,2020-04-27,2.55,
+6WRP,2020-04-29,2.08,
+6WS6,2020-04-30,3.3,
+6WT3,2020-05-01,2.85,
+6WT4,2020-05-01,1.78,
+6WT5,2020-05-01,2.8,
+6WT6,2020-05-01,2.41,
+6WT7,2020-05-01,2.9,
+6WX1,2020-05-09,2.0,
+6WXL,2020-05-11,2.76,
+6WYR,2020-05-13,1.8,
+6WYT,2020-05-13,1.75,
+6WZJ,2020-05-14,2.37,
+6WZK,2020-05-14,1.8,
+6WZL,2020-05-14,2.29,
+6WZM,2020-05-14,2.28,
+6WZY,2020-05-14,1.5,
+6X00,2020-05-14,1.55,
+6X1S,2020-05-19,1.65,
+6X1T,2020-05-19,2.34,
+6X1U,2020-05-19,1.641,
+6X1V,2020-05-19,2.11,
+6X1W,2020-05-19,1.95,
+6X3I,2020-05-21,2.268,
+6X4G,2020-05-22,3.5,
+6X4T,2020-05-23,3.15,
+6X5E,2020-05-26,2.29,
+6X6A,2020-05-27,3.6,
+6X6C,2020-05-27,2.9,
+6X87,2020-06-01,3.2,
+6X8P,2020-06-01,2.27,
+6X8Q,2020-06-01,1.6,
+6X8S,2020-06-01,1.55,
+6X8U,2020-06-01,1.55,
+6XC9,2020-06-08,2.4,
+6XCA,2020-06-08,1.8,
+6XCO,2020-06-08,2.9,
+6XCP,2020-06-08,3.3,
+6XF3,2020-06-15,2.38,
+6XF4,2020-06-15,2.77,
+6XJA,2020-06-23,4.0,
+6XJB,2020-06-23,3.8,
+6XKJ,2020-06-26,3.54,
+6XKK,2020-06-26,3.72,
+6XLI,2020-06-28,2.0,
+6XLQ,2020-06-29,3.0,
+6XLZ,2020-06-29,2.8,
+6XNN,2020-07-03,2.49,
+6XNO,2020-07-03,1.9,
+6XNP,2020-07-03,1.77,
+6XNT,2020-07-04,3.1,
+6XNW,2020-07-04,1.9,
+6XO1,2020-07-05,1.758,
+6XOC,2020-07-06,2.45,
+6XQA,2020-07-09,2.16,
+6XQP,2020-07-10,2.9,
+6XQQ,2020-07-10,2.68,
+6XQW,2020-07-10,2.991,
+6XRJ,2020-07-13,3.15,
+6XSN,2020-07-15,2.87,
+6XXV,2020-01-28,2.20116418766,
+6XY2,2020-01-29,3.05,
+6XYF,2020-01-30,1.11097,
+6XYM,2020-01-30,1.2,
+6XZ6,2020-02-02,2.7,
+6XZF,2020-02-04,1.8,
+6XZU,2020-02-05,1.5,
+6XZW,2020-02-05,2.4,
+6Y0D,2020-02-07,1.62,
+6Y0E,2020-02-07,1.5,
+6Y0L,2020-02-09,1.65,
+6Y0M,2020-02-09,1.5,
+6Y1K,2020-02-12,1.65,
+6Y1L,2020-02-12,1.4,
+6Y1M,2020-02-12,2.0,
+6Y1N,2020-02-12,2.2,
+6Y1R,2020-02-13,1.85,
+6Y26,2020-02-15,1.2,
+6Y27,2020-02-15,1.38,
+6Y28,2020-02-15,1.69,
+6Y29,2020-02-15,1.28,
+6Y2A,2020-02-15,1.25,
+6Y2B,2020-02-15,1.37,
+6Y41,2020-02-19,1.79,
+6Y43,2020-02-19,1.6,
+6Y49,2020-02-19,1.65,
+6Y54,2020-02-24,2.67,
+6Y5D,2020-02-25,4.1,
+6Y5E,2020-02-25,3.15,
+6Y6C,2020-02-26,2.26,
+6YAX,2020-03-14,2.8,
+6YCR,2020-03-18,1.54,
+6YHQ,2020-03-30,1.89,
+6YIO,2020-04-01,1.83,
+6YJP,2020-04-04,3.1,
+6YMQ,2020-04-09,3.07,
+6YO6,2020-04-14,6.0,
+6YSC,2020-04-22,2.05,
+6YSQ,2020-04-23,3.3,
+6YT7,2020-04-24,1.55,
+6YTB,2020-04-24,1.65,
+6YXK,2020-05-03,2.0,
+6YXL,2020-05-03,2.1,
+6YXM,2020-05-03,2.85,
+6YYE,2020-05-04,3.36,
+6Z1O,2020-05-14,3.2,
+6Z1Z,2020-05-14,1.7,
+6Z2G,2020-05-15,1.95,
+6Z3K,2020-05-20,2.7,
+6Z3X,2020-05-22,1.74,
+6Z6V,2020-05-29,2.19,
+6Z9V,2020-06-04,2.01,
+6Z9W,2020-06-04,2.7,
+6Z9X,2020-06-04,2.68,
+6ZDX,2020-06-15,3.0,
+6ZEC,2020-06-16,1.65,
+6ZFO,2020-06-17,4.4,
+6ZH1,2020-06-20,2.2,
+6ZJG,2020-06-29,2.45,
+6ZJZ,2020-06-29,2.489,
+6ZKW,2020-06-30,2.26,
+6ZKX,2020-06-30,2.17,
+6ZKY,2020-06-30,2.65,
+6ZKZ,2020-06-30,2.3,
+6ZPP,2020-07-09,1.5,
+6ZTD,2020-07-18,3.43,
+6ZTF,2020-07-20,1.55,
+6ZTR,2020-07-20,2.1,
+6ZVF,2020-07-24,1.9,
+6ZWA,2020-07-28,1.68,
+6ZWK,2020-07-28,1.55,
+7AAH,2020-09-04,1.4,
+7AD6,2020-09-14,2.75,
+7AD7,2020-09-14,2.3,
+7AFV,2020-09-20,2.4,
+7AH1,2020-09-23,2.0,
+7AJ6,2020-09-28,1.9,
+7AKK,2020-10-01,3.395,
+7ALO,2020-10-07,1.8,
+7ALV,2020-10-07,2.835,
+7AMA,2020-10-08,2.48,
+7AMG,2020-10-08,3.18,
+7AMP,2020-10-09,2.64,
+7AMQ,2020-10-09,2.353,
+7AMR,2020-10-09,1.949,
+7AMS,2020-10-09,2.419,
+7APZ,2020-10-20,1.97,
+7AQL,2020-10-22,1.8,
+7ARN,2020-10-25,1.57,
+7ARX,2020-10-26,2.42,
+7AW6,2020-11-06,1.95,
+7AWE,2020-11-06,2.288,
+7B12,2020-11-23,2.43,
+7B1B,2020-11-24,4.23,
+7B1C,2020-11-24,3.74,
+7B1D,2020-11-24,3.41,
+7B2M,2020-11-27,3.39,
+7B2P,2020-11-27,3.43,
+7B2Q,2020-11-27,3.76,
+7BAG,2020-12-15,2.0,
+7BAH,2020-12-15,1.89,
+7BAI,2020-12-15,3.4,
+7BBG,2020-12-17,2.64,
+7BBJ,2020-12-17,2.72,
+7BEA,2020-12-22,2.45,
+7BG1,2021-01-05,1.86,
+7BH8,2021-01-10,1.8,
+7BKP,2021-01-16,2.8,
+7BKQ,2021-01-17,3.4,
+7BM5,2021-01-19,2.95,
+7BNP,2021-01-22,1.7,
+7BNW,2021-01-22,2.59,
+7BST,2020-03-31,4.37,
+7BTO,2020-04-02,3.97,
+7BTP,2020-04-02,4.01,
+7BTQ,2020-04-02,4.54,
+7BTR,2020-04-02,4.54,
+7BUJ,2020-04-07,2.13,
+7BUM,2020-04-07,3.047,
+7BUQ,2020-04-07,3.091,
+7BXA,2020-04-18,3.32,
+7BXV,2020-04-21,1.75,
+7BYD,2020-04-22,2.80003270022,
+7C00,2020-04-29,1.7,
+7C3K,2020-05-12,2.6,
+7C76,2020-05-23,3.4,
+7C77,2020-05-23,3.3,
+7C88,2020-05-29,1.997,
+7C94,2020-06-04,2.84,
+7C95,2020-06-04,2.13,
+7C96,2020-06-05,2.51,
+7CEA,2020-06-22,2.55,
+7CEI,1998-09-17,2.3,
+7CHQ,2020-07-06,1.33,
+7CIQ,2020-07-08,1.59,
+7CIR,2020-07-08,1.81,
+7CIS,2020-07-08,2.1,
+7CJ2,2020-07-09,2.7,
+7CJQ,2020-07-12,2.7,
+7COE,2020-08-04,2.05,
+7CPO,2020-08-07,2.5,
+7CRF,2020-08-13,2.89,
+7CRV,2020-08-14,2.0,
+7CRW,2020-08-14,3.18,
+7CU5,2020-08-21,2.81,
+7CYN,2020-09-03,4.2,
+7CZD,2020-09-08,1.64,
+7D4B,2020-09-23,3.14,
+7D85,2020-10-07,2.5,
+7D9Z,2020-10-14,1.123,
+7DC6,2020-10-23,2.68,
+7DC7,2020-10-23,1.77,
+7DC8,2020-10-23,2.757,
+7DCV,2020-10-27,,
+7DFX,2020-11-10,2.996,
+7DG0,2020-11-10,1.895,
+7DHA,2020-11-13,2.55,
+7DHG,2020-11-14,2.2,
+7DNI,2020-12-09,3.2,
+7DNJ,2020-12-09,3.3,
+7DO4,2020-12-11,3.2,
+7DOH,2020-12-14,1.45,
+7DR4,2020-12-25,2.49,
+7DUU,2021-01-11,2.51,
+7DV4,2021-01-12,2.38,
+7DV6,2021-01-12,2.39,
+7DY5,2021-01-20,2.3,
+7DYN,2021-01-22,2.0,
+7DZM,2021-01-25,2.25,
+7DZN,2021-01-25,2.63,
+7E57,2021-02-18,3.302,
+7E6P,2021-02-23,2.5,
+7E9B,2021-03-04,1.78,
+7E9D,2021-03-04,1.89,
+7EA6,2021-03-06,2.18000239315,
+7EDO,2021-03-16,2.7,
+7EH3,2021-03-28,,
+7EI1,2021-03-30,3.9,
+7EJL,2021-04-02,1.89,
+7EJM,2021-04-02,1.71,
+7EJN,2021-04-02,2.11,
+7EKB,2021-04-05,1.45,
+7EKK,2021-04-05,1.7,
+7EM9,2021-04-13,1.9,
+7EMA,2021-04-13,1.8,
+7EMB,2021-04-13,1.97,
+7EMC,2021-04-13,1.9,
+7EMD,2021-04-13,1.7,
+7EQ3,2021-04-29,2.87,
+7ER3,2021-05-05,2.598,
+7EU2,2021-05-15,2.8,
+7EYC,2021-05-30,2.49,
+7EZY,2021-06-02,1.92,
+7F2S,2021-06-14,2.62,
+7F35,2021-06-15,2.6,
+7F45,2021-06-17,3.52,
+7F4W,2021-06-21,2.9,
+7F5K,2021-06-22,3.00002976572,
+7F7P,2021-06-30,2.03,
+7F9K,2021-07-04,2.18,
+7F9L,2021-07-04,2.7,
+7F9M,2021-07-04,2.9,
+7F9N,2021-07-04,3.0,
+7FAB,1991-11-20,2.0,
+7FCC,2021-07-14,2.144,
+7FCH,2021-07-14,1.883,
+7FCJ,2021-07-15,1.88,
+7FCL,2021-07-15,3.04,
+7FD3,2021-07-15,2.99,
+7FGJ,2021-07-27,1.89,
+7FGK,2021-07-27,2.3,
+7FGL,2021-07-27,2.1,
+7FGR,2021-07-27,2.2,
+7FI5,2021-07-30,2.39,
+7FI6,2021-07-30,2.9,
+7FI7,2021-07-30,2.78,
+7FI8,2021-07-30,2.8,
+7FI9,2021-07-30,2.16,
+7FJD,2021-08-03,3.2,
+7FJE,2021-08-03,3.0,
+7FJF,2021-08-03,3.1,
+7JFL,2020-07-17,1.68,
+7JFM,2020-07-17,2.23,
+7JG1,2020-07-18,3.3,
+7JG2,2020-07-18,3.3,
+7JGJ,2020-07-19,4.8,
+7JI2,2020-07-22,1.95,
+7JIC,2020-07-23,3.8,
+7JKB,2020-07-28,2.55,
+7JKM,2020-07-28,1.78,
+7JKS,2020-07-28,3.45,
+7JL4,2020-07-29,1.92,
+7JLK,2020-07-29,1.99,
+7JLN,2020-07-30,2.57,
+7JLU,2020-07-30,3.8,
+7JLV,2020-07-30,3.8,
+7JLX,2020-07-30,4.6,
+7JMO,2020-08-02,2.359,
+7JMX,2020-08-03,2.53,
+7JO8,2020-08-06,1.399,
+7JOO,2020-08-06,2.4,
+7JPT,2020-08-09,3.2,
+7JPU,2020-08-09,5.0,
+7JVD,2020-08-20,2.3,
+7JWG,2020-08-25,3.05,
+7JWI,2020-08-25,3.02,
+7JWJ,2020-08-25,3.251,
+7JWP,2020-08-26,3.0,
+7JWQ,2020-08-26,2.001,
+7JXC,2020-08-27,2.47,
+7JXD,2020-08-27,2.5,
+7JXE,2020-08-27,2.043,
+7JYU,2020-09-01,2.75,
+7JYV,2020-09-01,1.51,
+7JYW,2020-09-01,2.9,
+7JYX,2020-09-01,2.95,
+7JZ1,2020-09-01,3.37,
+7JZ4,2020-09-01,2.747,
+7JZI,2020-09-02,2.707,
+7JZK,2020-09-02,2.457,
+7K0C,2020-09-04,3.3,
+7K0X,2020-09-06,3.1,
+7K0Z,2020-09-06,3.2,
+7K3Q,2020-09-12,1.38,
+7K75,2020-09-22,2.5,
+7K76,2020-09-22,2.14,
+7K7R,2020-09-23,2.5,
+7K80,2020-09-24,2.4,
+7K81,2020-09-24,2.0,
+7K8N,2020-09-27,1.65,
+7K8O,2020-09-27,1.95,
+7K8P,2020-09-27,1.8,
+7K8Q,2020-09-27,2.0,
+7K8R,2020-09-27,2.0,
+7K9Z,2020-09-29,2.95,
+7KC1,2020-10-04,3.41,
+7KCZ,2020-10-07,3.15,
+7KE1,2020-10-09,1.5,
+7KEI,2020-10-10,1.75,
+7KET,2020-10-12,2.0,
+7KEU,2020-10-12,3.9,
+7KEZ,2020-10-13,2.31,
+7KF0,2020-10-13,2.32,
+7KF1,2020-10-13,2.45,
+7KFG,2020-10-13,3.002,
+7KFK,2020-10-14,2.63,
+7KGO,2020-10-18,2.15,
+7KGP,2020-10-18,1.396,
+7KGQ,2020-10-18,1.34,
+7KGR,2020-10-18,1.55,
+7KGS,2020-10-18,1.58,
+7KGT,2020-10-18,1.9,
+7KGU,2020-10-18,2.4,
+7KHD,2020-10-21,2.95610193196,
+7KHF,2020-10-21,3.54,
+7KHX,2020-10-22,3.20569845167,
+7KKJ,2020-10-27,2.05,
+7KM6,2020-11-02,1.67,
+7KOZ,2020-11-10,2.25,
+7KP0,2020-11-10,2.4,
+7KP1,2020-11-10,2.02,
+7KPJ,2020-11-11,2.1,
+7KQK,2020-11-16,2.6,
+7KQL,2020-11-16,1.49,
+7KQY,2020-11-18,2.913,
+7KVX,2020-11-29,2.48,
+7KVZ,2020-11-29,2.35,
+7KW1,2020-11-29,1.8,
+7KX0,2020-12-02,2.69,
+7KX4,2020-12-03,2.6,
+7KZA,2020-12-10,1.69,
+7KZC,2020-12-10,2.3,
+7L15,2020-12-14,2.25,
+7L1B,2020-12-14,2.04,
+7L1C,2020-12-14,1.96,
+7L1D,2020-12-14,3.11,
+7L2G,2020-12-17,,
+7L6M,2020-12-23,4.7,
+7L77,2020-12-27,1.543,
+7L79,2020-12-27,2.826,
+7L7V,2020-12-30,2.95,
+7L7W,2020-12-30,2.55,
+7LA7,2021-01-06,1.55100728206,
+7LCN,2021-01-11,3.35,
+7LCV,2021-01-11,1.7,
+7LD1,2021-01-12,3.4,
+7LF7,2021-01-15,2.026,
+7LF8,2021-01-15,2.15,
+7LFA,2021-01-15,1.857,
+7LFB,2021-01-16,1.913,
+7LFD,2021-01-16,2.157,
+7LFH,2021-01-17,4.2,
+7LFI,2021-01-17,1.7,
+7LFJ,2021-01-17,1.7,
+7LFK,2021-01-17,1.6,
+7LFL,2021-01-17,1.6,
+7LFM,2021-01-17,1.6,
+7LGD,2021-01-20,2.88,
+7LGT,2021-01-21,1.97,
+7LK9,2021-02-01,3.4,
+7LKA,2021-02-02,1.981,
+7LLI,2021-02-04,3.2,
+7LLJ,2021-02-04,3.15,
+7LMN,2021-02-05,2.01,
+7LMO,2021-02-05,1.99,
+7LMP,2021-02-05,2.29,
+7LMQ,2021-02-05,1.91,
+7LMR,2021-02-05,2.09,
+7LQ7,2021-02-13,3.4,
+7LT1,2021-02-18,2.4,
+7LT2,2021-02-18,1.58,
+7LUD,2021-02-22,2.9,
+7LUR,2021-02-23,1.95,
+7LUS,2021-02-23,2.45,
+7LVU,2021-02-26,1.94,
+7LYV,2021-03-08,1.9,
+7LYW,2021-03-08,2.51,
+7LZ6,2021-03-09,7.3,
+7M1C,2021-03-12,2.1,
+7M3Y,2021-03-19,1.69,
+7M3Z,2021-03-19,1.4,
+7M41,2021-03-19,1.79,
+7M6K,2021-03-25,1.69,
+7M8S,2021-03-30,2.35,
+7M8T,2021-03-30,1.5,
+7M8U,2021-03-30,1.45,
+7MF7,2021-04-08,2.0,
+7MF8,2021-04-08,2.2,
+7MF9,2021-04-08,3.7,
+7MFA,2021-04-08,2.4,
+7MFB,2021-04-08,1.74,
+7MFR,2021-04-10,2.848,
+7MFV,2021-04-11,1.9,
+7MHC,2021-04-15,2.32,
+7MJ6,2021-04-19,1.95,
+7MJ7,2021-04-19,1.6,
+7MJ8,2021-04-19,1.79,
+7MJ9,2021-04-19,1.75,
+7MJA,2021-04-19,1.69,
+7MLE,2021-04-28,2.2,
+7MLM,2021-04-28,2.104,
+7MPG,2021-05-04,3.4,
+7MSG,2021-05-11,3.5,
+7MSJ,2021-05-11,2.1,
+7MU4,2021-05-14,1.83,
+7MWY,2021-05-17,1.84,
+7MWZ,2021-05-17,2.0,
+7MX8,2021-05-18,2.02,
+7MXI,2021-05-19,2.8,
+7MYT,2021-05-21,2.1,
+7N04,2021-05-25,1.70000520394,
+7N05,2021-05-25,1.7,
+7N07,2021-05-25,2.4,
+7N08,2021-05-25,2.0,
+7N0X,2021-05-26,2.0,
+7N19,2021-05-27,2.38,
+7N1A,2021-05-27,2.065,
+7N1B,2021-05-27,2.81,
+7N1C,2021-05-27,1.881,
+7N1D,2021-05-27,2.35,
+7N1E,2021-05-27,2.3,
+7N1F,2021-05-27,2.393,
+7N2N,2021-05-29,2.6,
+7N2O,2021-05-29,2.3,
+7N2P,2021-05-29,2.5,
+7N2Q,2021-05-29,2.7,
+7N2R,2021-05-29,2.28,
+7N2S,2021-05-29,2.37,
+7N34,2021-05-31,1.9,
+7N35,2021-05-31,2.6,
+7N3E,2021-06-01,2.06,
+7N3F,2021-06-01,1.9,
+7N3G,2021-06-01,1.42,
+7N3H,2021-06-01,1.26,
+7N4K,2021-06-04,1.85,
+7N50,2021-06-04,1.5,
+7N51,2021-06-04,1.67,
+7N52,2021-06-04,2.9,
+7N5C,2021-06-05,1.87,
+7N5P,2021-06-06,2.09,
+7N5Q,2021-06-06,1.76,
+7N6P,2021-06-08,2.15,
+7N8Q,2021-06-15,2.9,
+7N9J,2021-06-18,1.74,
+7NA5,2021-06-19,2.5,
+7NC0,2021-01-28,2.2,
+7NDQ,2021-02-02,2.551,
+7NDT,2021-02-02,2.999,
+7NDU,2021-02-02,2.9,
+7NFA,2021-02-05,2.3,
+7NJZ,2021-02-17,3.2,
+7NLD,2021-02-22,2.3,
+7NMC,2021-02-23,1.2,
+7NMD,2021-02-23,2.25,
+7NME,2021-02-23,2.2,
+7NMF,2021-02-23,2.98,
+7NMG,2021-02-23,2.48,
+7NMO,2021-02-23,1.2,
+7NMR,2021-02-23,1.15,
+7NMT,2021-02-23,1.2,
+7NMV,2021-02-23,1.51,
+7NMY,2021-02-23,1.25,
+7NN5,2021-02-24,1.242,
+7NOZ,2021-02-26,3.9,
+7NP9,2021-02-26,1.14,
+7NSL,2021-03-08,3.1,
+7NSX,2021-03-08,1.9,
+7NSY,2021-03-08,1.4,
+7NSZ,2021-03-08,1.3,
+7NT0,2021-03-08,1.8,
+7NW3,2021-03-16,3.20001097294,
+7NYC,2021-03-22,3.54,
+7NYD,2021-03-22,3.27,
+7NZE,2021-03-24,2.05,
+7NZF,2021-03-24,1.9,
+7NZH,2021-03-24,2.831,
+7O00,2021-03-25,2.24,
+7O2Z,2021-04-01,2.55,
+7O30,2021-04-01,2.65,
+7O31,2021-04-01,1.55,
+7O33,2021-04-01,1.85,
+7O4Y,2021-04-07,1.6,
+7O52,2021-04-07,2.41,
+7ODU,2021-04-30,3.0,
+7OM4,2021-05-21,6.05,
+7OM5,2021-05-21,1.48,
+7OMN,2021-05-24,1.7,
+7OMT,2021-05-24,2.0,
+7ON5,2021-05-25,1.25,
+7OOI,2021-05-27,2.28,
+7OP0,2021-05-28,2.57,
+7OW1,2021-06-16,1.4,
+7OW3,2021-06-16,2.46,
+7OW4,2021-06-16,1.81,
+7OW5,2021-06-16,2.58,
+7OW6,2021-06-16,2.64,
+7OWC,2021-06-17,1.85,
+7OWD,2021-06-17,1.71,
+7OXN,2021-06-22,2.5,
+7P0A,2021-06-29,2.429,
+7P0T,2021-06-30,2.605,
+7P2D,2021-07-05,3.2,
+7P3D,2021-07-07,1.67,
+7P3E,2021-07-07,2.0,
+7P49,2021-07-10,2.05,
+7P4B,2021-07-10,1.72,
+7PAG,2021-07-29,4.0,
+7PB2,2021-07-30,3.41,
+7PBC,2021-08-02,2.04,
+7PBE,2021-08-02,3.0,
+7PDW,2021-08-09,1.82,
+7PDX,2021-08-09,2.27,
+7PDY,2021-08-09,2.54,
+7PHR,2021-08-18,3.08,
+7PHS,2021-08-18,2.77,
+7PHU,2021-08-18,2.53,
+7PHV,2021-08-18,3.091,
+7PHW,2021-08-18,2.793,
+7PI2,2021-08-19,3.14,
+7PI3,2021-08-19,3.269,
+7PI6,2021-08-19,2.6,
+7PI7,2021-08-19,2.72,
+7PK9,2021-08-25,2.8,
+7PKB,2021-08-25,3.2,
+7PKD,2021-08-25,3.3,
+7PKE,2021-08-25,3.3,
+7PKF,2021-08-25,2.8,
+7PKG,2021-08-25,3.3,
+7PKH,2021-08-25,3.0,
+7PKL,2021-08-25,2.35,
+7PQN,2021-09-17,2.40001520992,
+7PQO,2021-09-17,3.39,
+7PZC,2021-10-12,3.9,
+7PZD,2021-10-12,3.6,
+7Q15,2021-10-18,3.301,
+7Q1Y,2021-10-22,4.4,
+7Q3B,2021-10-27,2.55733924728,
+7Q3P,2021-10-28,2.1,
+7Q4Q,2021-11-01,1.65,
+7Q5Z,2021-11-05,3.25,
+7Q60,2021-11-05,3.13,
+7Q61,2021-11-05,2.88,
+7Q62,2021-11-05,3.18,
+7Q6C,2021-11-06,2.29274,
+7Q85,2021-11-10,2.359,
+7Q98,2021-11-12,2.5,
+7Q99,2021-11-12,2.55,
+7Q9A,2021-11-12,2.1,
+7Q9B,2021-11-12,3.24,
+7QCQ,2021-11-25,1.7,
+7QDO,2021-11-27,3.6,
+7QHP,2021-12-13,1.82,
+7QIV,2021-12-16,2.8,
+7QNG,2021-12-20,2.7,
+7QPD,2022-01-03,3.73,
+7QPJ,2022-01-04,1.54,
+7QT0,2022-01-14,2.07,
+7QT2,2022-01-14,1.92,
+7QT3,2022-01-14,1.7,
+7QT4,2022-01-14,2.32,
+7QTR,2022-01-15,,
+7QTS,2022-01-15,,
+7QU1,2022-01-17,1.91,
+7QU2,2022-01-17,2.5,
+7QU6,2022-01-17,2.34,
+7QU8,2022-01-17,3.37,
+7QUH,2022-01-18,2.867,
+7QUI,2022-01-18,3.352,
+7R20,2022-02-03,1.42,
+7R4H,2022-02-08,2.34,
+7R52,2022-02-10,2.943,
+7R53,2022-02-10,3.121,
+7R54,2022-02-10,2.836,
+7R63,2021-06-22,2.0,
+7R73,2021-06-24,1.76,
+7R74,2021-06-24,2.76,
+7R7Z,2021-06-25,2.286,
+7RA7,2021-06-30,2.2,
+7RAI,2021-07-01,3.24,
+7RAJ,2021-07-01,3.0,
+7RAQ,2021-07-02,1.74,
+7RAV,2021-07-02,3.3,
+7RCO,2021-07-07,2.9,
+7RCS,2021-07-08,2.4,
+7RD3,2021-07-09,1.81,
+7RD4,2021-07-09,1.75,
+7RD9,2021-07-09,1.91,
+7RDA,2021-07-09,1.92,
+7RDJ,2021-07-09,1.93,
+7RDK,2021-07-09,2.46,
+7RDL,2021-07-09,2.71,
+7RDM,2021-07-09,2.08,
+7RDV,2021-07-11,2.90006610312,
+7RDW,2021-07-12,3.55,
+7RE7,2021-07-12,2.547,
+7RE8,2021-07-12,2.82,
+7RE9,2021-07-12,2.77,
+7RFP,2021-07-14,4.4,
+7RG7,2021-07-14,1.83,
+7RGA,2021-07-14,2.9,
+7RHO,2021-07-18,2.0,
+7RI1,2021-07-19,2.55,
+7RI2,2021-07-19,2.8,
+7RK7,2021-07-22,2.54,
+7RM4,2021-07-26,3.33,
+7RNO,2021-07-29,,
+7RPP,2021-08-04,2.2,
+7RPR,2021-08-04,1.9,
+7RPS,2021-08-04,2.09,
+7RQP,2021-08-06,2.98,
+7RQQ,2021-08-06,1.89,
+7RQR,2021-08-06,2.23,
+7RRG,2021-08-09,2.12,
+7RTD,2021-08-13,2.05,
+7RTH,2021-08-13,3.19,
+7RTP,2021-08-13,2.09,
+7RTR,2021-08-14,2.6,
+7RXI,2021-08-23,2.15,
+7RXJ,2021-08-23,2.345,
+7RXL,2021-08-23,1.823,
+7RXP,2021-08-23,1.761,
+7RYL,2021-08-25,2.0,
+7RYM,2021-08-25,3.2,
+7RYN,2021-08-25,2.7,
+7RYO,2021-08-25,3.0,
+7RYU,2021-08-26,1.51,
+7RYV,2021-08-26,2.5,
+7RZD,2021-08-27,1.82,
+7RZJ,2021-08-27,1.8,
+7S08,2021-08-30,2.42,
+7S0J,2021-08-30,2.15,
+7S0X,2021-08-31,2.8,
+7S11,2021-08-31,2.58,
+7S13,2021-08-31,2.12,
+7S1B,2021-09-02,3.03,
+7S4N,2021-09-09,1.65,
+7S58,2021-09-10,1.82,
+7S59,2021-09-10,2.39,
+7S79,2021-09-15,1.53,
+7S7D,2021-09-15,1.56,
+7S7E,2021-09-15,2.04,
+7S7F,2021-09-15,1.88,
+7S7I,2021-09-16,2.4,
+7S8A,2021-09-17,2.1,
+7S8E,2021-09-17,1.6,
+7S8F,2021-09-17,1.8,
+7S8I,2021-09-17,1.66,
+7S8J,2021-09-17,1.92,
+7S8Q,2021-09-19,2.08,
+7S8R,2021-09-19,2.95,
+7S8S,2021-09-19,1.87,
+7S9V,2021-09-21,3.3,
+7S9W,2021-09-21,3.4,
+7SA2,2021-09-21,1.85,
+7SA6,2021-09-22,2.9,
+7SAH,2021-09-22,1.6,
+7SAI,2021-09-22,2.23,
+7SAJ,2021-09-22,2.37,
+7SAK,2021-09-22,1.15,
+7SAL,2021-09-22,1.93,
+7SAY,2021-09-23,2.1,
+7SBI,2021-09-24,2.23,
+7SBU,2021-09-25,2.53,
+7SBZ,2021-09-26,2.9,
+7SCS,2021-09-29,1.51,
+7SCT,2021-09-29,1.84,
+7SCU,2021-09-29,1.86,
+7SCV,2021-09-29,2.01,
+7SD2,2021-09-29,3.75,
+7SEN,2021-09-30,2.09,
+7SFX,2021-10-04,3.1,
+7SG0,2021-10-04,3.0,
+7SG1,2021-10-04,3.1,
+7SG2,2021-10-04,3.1,
+7SG5,2021-10-05,1.4,
+7SG6,2021-10-05,1.55,
+7SH4,2021-10-07,2.0,
+7SHO,2021-10-10,2.25,
+7SHP,2021-10-11,2.2,
+7SHT,2021-10-11,7.29,
+7SHU,2021-10-11,2.75,
+7SHY,2021-10-11,3.0,
+7SHZ,2021-10-11,3.0,
+7SI0,2021-10-12,3.0,
+7SIF,2021-10-14,1.73,
+7SIG,2021-10-14,1.741,
+7SIH,2021-10-14,1.9,
+7SII,2021-10-14,3.45,
+7SIS,2021-10-14,1.9,
+7SIY,2021-10-15,1.48,
+7SJM,2021-10-18,1.8,
+7SJP,2021-10-18,2.1,
+7SJS,2021-10-18,1.612,
+7SN1,2021-10-27,1.467,
+7SN2,2021-10-27,4.3,
+7SO0,2021-10-28,1.74,
+7SQP,2021-11-05,2.53,
+7SR0,2021-11-07,2.54,
+7SR3,2021-11-07,2.49,
+7SR4,2021-11-07,2.59,
+7SR5,2021-11-07,2.35,
+7SRK,2021-11-08,2.5,
+7SSH,2021-11-11,2.73,
+7SSM,2021-11-11,1.96,
+7SSV,2021-11-11,3.39,
+7SSX,2021-11-11,2.89,
+7SSY,2021-11-11,2.89,
+7SSZ,2021-11-11,3.25,
+7ST5,2021-11-12,2.2,
+7ST8,2021-11-12,2.75,
+7STF,2021-11-12,3.14,
+7SU0,2021-11-15,2.41,
+7SU1,2021-11-15,2.53,
+7SU9,2021-11-16,1.99,
+7T0F,2021-11-29,2.0,
+7T0G,2021-11-29,1.53,
+7T0H,2021-11-29,1.3,
+7T0I,2021-11-29,2.1,
+7T0J,2021-11-29,2.15,
+7T0K,2021-11-29,2.0,
+7T0L,2021-11-29,3.0,
+7T1E,2021-12-01,1.459,
+7T1W,2021-12-02,2.45,
+7T1X,2021-12-02,2.6,
+7T25,2021-12-03,2.25,
+7T2A,2021-12-03,3.04,
+7T2B,2021-12-03,2.8,
+7T2C,2021-12-03,3.1,
+7T2D,2021-12-03,3.4,
+7T5M,2021-12-12,1.67,
+7T62,2021-12-13,21.0,
+7T6I,2021-12-13,2.3,
+7T83,2021-12-15,2.1,
+7T84,2021-12-15,1.6,
+7T97,2021-12-18,2.144,
+7T98,2021-12-18,2.97,
+7T99,2021-12-18,2.65,
+7TBA,2021-12-21,3.5,
+7TE3,2022-01-04,2.2,
+7TE4,2022-01-04,2.456,
+7TI6,2022-01-12,2.64,
+7TJC,2022-01-16,1.35,
+7TLT,2022-01-18,2.3,
+7TP3,2022-01-24,2.33,
+7TPS,2022-01-26,3.15,
+7TQA,2022-01-26,2.328,
+7TR4,2022-01-27,2.3,
+7TTZ,2022-02-02,2.35,
+7TUC,2022-02-02,1.25,
+7TUD,2022-02-02,1.45,
+7TUE,2022-02-02,3.1,
+7TUF,2022-02-02,2.8,
+7TUG,2022-02-02,3.9,
+7TUH,2022-02-02,2.3,
+7TUS,2022-02-03,2.4,
+7TUY,2022-02-03,2.98,
+7TUZ,2022-02-03,3.12,
+7TV9,2022-02-04,3.4,
+7TXR,2022-02-09,2.0,
+7TXW,2022-02-10,2.17,
+7U04,2022-02-17,2.31,
+7U0K,2022-02-18,1.73,
+7U1R,2022-02-22,1.8,
+7U21,2022-02-22,1.9,
+7U5G,2022-03-02,1.84,
+7U61,2022-03-03,2.1,
+7U62,2022-03-03,1.82,
+7U63,2022-03-03,2.3,
+7U64,2022-03-03,1.75,
+7U68,2022-03-03,2.0,
+7U8C,2022-03-08,1.74,
+7UC5,2022-03-16,1.95,
+7UE9,2022-03-21,1.75,
+7UED,2022-03-21,3.0,
+7UEL,2022-03-22,1.9,
+7UEM,2022-03-22,2.314,
+7UEN,2022-03-22,1.55,
+7UFJ,2022-03-22,2.5,
+7UFN,2022-03-22,2.2,
+7UFO,2022-03-23,1.8,
+7UFQ,2022-03-23,2.3,
+7UGM,2022-03-25,1.4,
+7UIJ,2022-03-29,2.701,
+7UM2,2022-04-06,1.63,
+7UM3,2022-04-06,2.3983,
+7UMG,2022-04-06,2.4,
+7UNB,2022-04-10,2.18,
+7UQC,2022-04-19,2.65,
+7UR1,2022-04-21,2.17,
+7URU,2022-04-22,2.4,
+7UT3,2022-04-26,3.0,
+7UVF,2022-05-01,2.6,
+7UVK,2022-05-02,3.28,
+7UVL,2022-05-02,3.56,
+7UX5,2022-05-05,3.35,
+7UXL,2022-05-05,2.86,
+7UXO,2022-05-05,2.25,
+7UXP,2022-05-05,2.62,
+7UXQ,2022-05-05,2.89,
+7V0V,2022-05-11,,
+7V3Q,2021-08-11,2.98,
+7V4I,2021-08-13,3.3,
+7V4J,2021-08-13,3.5,
+7V4K,2021-08-13,,
+7V4L,2021-08-13,3.4,
+7V4W,2021-08-15,2.1,
+7V63,2021-08-19,2.906,
+7V64,2021-08-19,1.56,
+7V7K,2021-08-21,2.2,
+7V8Q,2021-08-23,3.2,
+7VAC,2021-08-28,3.5,
+7VAZ,2021-08-30,2.73,
+7VEN,2021-09-09,1.45,
+7VMU,2021-10-09,2.89,
+7VMZ,2021-10-10,2.85,
+7VPY,2021-10-18,1.6,
+7VS2,2021-10-25,2.5,
+7VTJ,2021-10-29,2.0,
+7VTP,2021-10-30,3.23,
+7VTQ,2021-10-30,3.55,
+7VU5,2021-11-01,,
+7VUX,2021-11-04,1.64,
+7VYT,2021-11-15,1.53,
+7W7Q,2021-12-06,1.96,
+7WBG,2021-12-16,2.0,
+7WBI,2021-12-16,1.8,
+7WBT,2021-12-17,2.75,
+7WBU,2021-12-17,3.42,
+7WC0,2021-12-17,2.705,
+7WCY,2021-12-20,2.36,
+7WDK,2021-12-21,3.05,
+7WDL,2021-12-22,1.903,
+7WDM,2021-12-22,2.123,
+7WG3,2021-12-28,2.19,
+7WGE,2021-12-28,3.4,
+7WHU,2021-12-31,2.89,
+7WJ2,2022-01-05,1.28,
+7WJ3,2022-01-05,1.5634361884,
+7WKI,2022-01-10,2.6,
+7WKJ,2022-01-10,1.5,
+7WPV,2022-01-24,2.46,
+7WSL,2022-01-30,1.534,
+7WSO,2022-01-30,3.03,
+7WSP,2022-01-30,4.09,
+7WT3,2022-02-03,1.88765498464,
+7WT4,2022-02-03,1.89459140677,
+7WT5,2022-02-03,2.09507668635,
+7WZZ,2022-02-20,1.305,
+7X00,2022-02-20,1.45,
+7X1B,2022-02-23,1.399,
+7X1C,2022-02-23,1.409,
+7X3N,2022-03-01,2.24,
+7X8V,2022-03-15,1.84,
+7X9P,2022-03-15,2.7,
+7X9Q,2022-03-15,2.4,
+7XAD,2022-03-17,3.0,
+7XAE,2022-03-17,3.44,
+7XF3,2022-03-31,1.91,
+7XFW,2022-04-02,2.07,
+7XFX,2022-04-02,2.28,
+7XFY,2022-04-02,2.67,
+7XI1,2022-04-11,2.53,
+7XI5,2022-04-12,1.76,
+7XJF,2022-04-16,2.6,
+7XL0,2022-04-20,1.7,
+7XL1,2022-04-20,1.65,
+7XP9,2022-05-04,1.93,
+7XPC,2022-05-04,3.31,
+7XQS,2022-05-08,2.69,
+7XQT,2022-05-08,2.8,
+7XQU,2022-05-08,2.6,
+7XRZ,2022-05-12,2.1,
+7XT6,2022-05-16,3.63,
+7XU8,2022-05-18,2.15,
+7XVI,2022-05-23,3.11,
+7XVK,2022-05-24,2.29,
+7XYQ,2022-06-02,2.85,
+7Y09,2022-06-03,3.71,
+7Y0G,2022-06-05,2.08,
+7Y0H,2022-06-05,3.56,
+7Y0J,2022-06-05,3.62,
+7Y3J,2022-06-11,2.6,
+7YD4,2022-07-03,1.896,
+7YDS,2022-07-04,2.3,
+7YG2,2022-07-09,3.32,
+7YG3,2022-07-11,1.5,
+7YGG,2022-07-11,2.76,
+7YHR,2022-07-14,1.45,
+7YIZ,2022-07-18,2.42,
+7YLF,2022-07-26,1.9,
+7YLG,2022-07-26,1.8,
+7YPC,2022-08-03,2.66,
+7YSG,2022-08-12,3.18,
+7YTC,2022-08-14,3.39,
+7YTD,2022-08-14,3.71,
+7YTE,2022-08-14,3.0,
+7YTP,2022-08-15,2.77,
+7YTX,2022-08-16,2.9,
+7YX9,2022-02-15,1.76,
+7YXB,2022-02-15,2.095,
+7YXU,2022-02-16,2.31,
+7YZW,2022-02-21,1.6,
+7Z0Q,2022-02-23,2.1,
+7Z1X,2022-02-25,1.86,
+7Z2M,2022-02-28,1.899,
+7Z3W,2022-03-02,2.0,
+7Z4T,2022-03-04,3.3,
+7Z50,2022-03-06,2.65,
+7ZAK,2022-03-22,1.62,
+7ZF6,2022-04-01,2.21,
+7ZFF,2022-04-01,2.32,
+7ZFR,2022-04-01,2.9,
+7ZGJ,2022-04-03,3.58,
+7ZGK,2022-04-03,3.59,
+7ZGU,2022-04-04,3.4,
+7ZJM,2022-04-11,2.59,
+7ZL1,2022-04-13,2.5,
+7ZOR,2022-04-26,3.933,
+7ZOZ,2022-04-26,2.104,
+7ZQI,2022-04-29,2.15,
+7ZQJ,2022-04-29,2.25,
+7ZT2,2022-05-09,2.4,
+7ZT3,2022-05-09,2.4,
+7ZT4,2022-05-09,2.02,
+7ZT5,2022-05-09,2.09,
+7ZT7,2022-05-09,1.84,
+7ZT8,2022-05-09,2.29,
+7ZT9,2022-05-09,2.13,
+7ZUC,2022-05-12,1.89,
+8A1D,2022-06-01,3.0,
+8A1S,2022-06-02,4.0,
+8A2I,2022-06-03,2.16,
+8A2J,2022-06-03,2.32,
+8A2K,2022-06-03,1.89,
+8A47,2022-06-10,2.338,
+8A48,2022-06-10,3.044,
+8A49,2022-06-10,3.45,
+8A8M,2022-06-23,4.0,
+8ACF,2022-07-05,1.8,
+8ACI,2022-07-05,1.85,
+8ADY,2022-07-12,5.2,
+8ADZ,2022-07-12,6.7,
+8AE0,2022-07-12,7.1,
+8AE2,2022-07-12,8.5,
+8AE3,2022-07-12,6.8,
+8AG1,2022-07-19,3.303,
+8ALX,2022-08-01,1.1,
+8ANE,2022-08-05,3.2,
+8AOK,2022-08-08,1.6,
+8AOM,2022-08-08,2.202,
+8AON,2022-08-08,2.1,
+8AVA,2022-08-26,1.354,
+8AWH,2022-08-29,1.42,
+8AWL,2022-08-30,1.62,
+8AXH,2022-08-31,1.85,
+8AYH,2022-09-02,3.35,
+8AZA,2022-09-05,3.15,
+8B0F,2022-09-07,3.0,
+8B28,2022-09-13,1.75,
+8B2J,2022-09-14,2.174,
+8B50,2022-09-21,1.67,
+8BBH,2022-10-13,1.619,
+8BE1,2022-10-21,1.98,
+8BF0,2022-10-23,1.75,
+8BH5,2022-10-29,2.38,
+8BJZ,2022-11-08,1.89,
+8BLQ,2022-11-10,3.97,
+8BP6,2022-11-16,2.8,
+8BPE,2022-11-16,3.63,
+8BPF,2022-11-16,3.5,
+8BPG,2022-11-16,3.1,
+8BS8,2022-11-24,1.59,
+8BSO,2022-11-25,1.92,
+8BTB,2022-11-28,14.0,
+8C1B,2022-12-20,3.8,
+8C1C,2022-12-20,4.1,
+8C67,2023-01-11,1.88,
+8C7H,2023-01-16,2.7,
+8C7J,2023-01-16,2.0,
+8C7V,2023-01-17,1.61,
+8C8T,2023-01-21,3.2,
+8CBX,2023-01-26,2.0,
+8CBY,2023-01-26,2.27,
+8CBZ,2023-01-26,1.86,
+8CC0,2023-01-26,1.85,
+8CC1,2023-01-26,2.0,
+8CDS,2023-02-01,1.53,
+8CDT,2023-02-01,1.41,
+8CEM,2023-02-02,3.0,
+8CGF,2023-02-04,,
+8CH7,2023-02-07,,
+8CHA,2023-02-07,1.81,
+8CI3,2023-02-08,2.33,
+8CIF,2023-02-09,2.2,
+8CJV,2023-02-13,2.84,
+8CMB,2023-02-19,1.84,
+8CMC,2023-02-19,1.42,
+8CMD,2023-02-19,2.54,
+8CME,2023-02-19,2.26,
+8CMF,2023-02-19,2.2,
+8CMG,2023-02-19,1.64,
+8CMH,2023-02-19,1.64,
+8CMI,2023-02-19,2.6,
+8CML,2023-02-20,3.6,
+8COE,2023-02-28,4.2,
+8COH,2023-02-28,1.3,
+8CQB,2023-03-04,3.7,
+8CWI,2022-05-19,1.873,
+8CWJ,2022-05-19,2.449,
+8CWK,2022-05-19,2.368,
+8CWU,2022-05-19,1.71,
+8CWV,2022-05-19,2.51,
+8CX4,2022-05-19,2.2,
+8CZD,2022-05-24,4.6,
+8CZO,2022-05-25,4.3,
+8D36,2022-05-31,1.45,
+8D54,2022-06-03,1.4,
+8D5E,2022-06-04,2.46,
+8D5F,2022-06-04,2.31,
+8D5J,2022-06-04,1.95,
+8D5K,2022-06-05,2.066,
+8D5N,2022-06-05,1.8,
+8D5P,2022-06-05,2.75,
+8D5Q,2022-06-05,2.501,
+8D6Z,2022-06-06,2.3,
+8DAO,2022-06-13,2.8,
+8DE6,2022-06-20,3.2,
+8DF1,2022-06-21,3.3,
+8DFL,2022-06-22,3.25,
+8DFW,2022-06-22,2.1,
+8DFX,2022-06-22,5.55,
+8DFY,2022-06-22,3.552,
+8DG8,2022-06-23,3.62,
+8DG9,2022-06-23,2.24,
+8DGG,2022-06-23,3.78,
+8DGR,2022-06-24,1.56,
+8DGU,2022-06-24,1.89,
+8DGV,2022-06-24,2.3,
+8DGW,2022-06-24,2.81,
+8DGX,2022-06-24,2.89,
+8DIN,2022-06-29,2.5,
+8DIR,2022-06-29,2.3,
+8DJ7,2022-06-30,2.39,
+8DKF,2022-07-05,1.79,
+8DNT,2022-07-11,3.18,
+8DOZ,2022-07-14,1.7,
+8DS5,2022-07-21,1.926,
+8DTR,2022-07-26,1.5,
+8DTT,2022-07-26,1.75,
+8DTX,2022-07-26,1.6,
+8DUL,2022-07-27,4.17,
+8DUN,2022-07-27,5.84,
+8DUZ,2022-07-27,1.65,
+8DV3,2022-07-28,1.9,
+8DV4,2022-07-28,2.4,
+8DVG,2022-07-28,2.594,
+8DY0,2022-08-03,2.1,
+8DY1,2022-08-03,2.68,
+8DY2,2022-08-03,1.65,
+8DY3,2022-08-03,1.509,
+8DY4,2022-08-03,2.4,
+8DY5,2022-08-03,2.2,
+8DYT,2022-08-05,3.3,
+8DYW,2022-08-05,3.72,
+8DYX,2022-08-05,3.0,
+8DYY,2022-08-05,3.62,
+8DZ3,2022-08-06,2.7,
+8DZ4,2022-08-06,3.2,
+8DZ5,2022-08-06,3.84,
+8E13,2022-08-09,1.37,
+8E1B,2022-08-10,1.65,
+8E1C,2022-08-10,1.9,
+8E2N,2022-08-15,1.1,
+8E2Z,2022-08-16,1.13,
+8E4C,2022-08-18,4.0,
+8E8I,2022-08-25,1.49,
+8EB2,2022-08-30,2.9,
+8EC3,2022-09-01,1.5,
+8EC5,2022-09-01,1.22,
+8ECQ,2022-09-02,2.0,
+8ECV,2022-09-02,1.81,
+8ECZ,2022-09-02,2.82,
+8ED1,2022-09-02,2.31,
+8EDF,2022-09-04,3.4,
+8EE2,2022-09-06,2.4,
+8EE4,2022-09-06,2.6,
+8EE7,2022-09-06,2.72,
+8EEA,2022-09-06,2.6,
+8EEZ,2022-09-07,2.25,
+8EF0,2022-09-07,2.55,
+8EF1,2022-09-07,1.87,
+8EF2,2022-09-07,2.102,
+8EFM,2022-09-08,2.13,
+8EFN,2022-09-08,1.73,
+8EH5,2022-09-13,3.36,
+8EK1,2022-09-19,3.6,
+8EK6,2022-09-20,1.954,
+8EKA,2022-09-20,3.7,
+8EKD,2022-09-20,3.6,
+8EKF,2022-09-20,1.9,
+8EKH,2022-09-21,2.7,
+8ELI,2022-09-24,1.49,
+8ELN,2022-09-26,2.4,
+8EMA,2022-09-27,8.2,
+8EMF,2022-09-27,1.80482421415,
+8EMG,2022-09-27,1.83001273614,
+8EMI,2022-09-27,1.57301511861,
+8EMJ,2022-09-27,1.75002880736,
+8EMK,2022-09-27,1.66523002948,
+8EN8,2022-09-29,2.70001191123,
+8ENH,2022-09-30,2.50003195312,
+8ENU,2022-09-30,3.22,
+8EO8,2022-10-02,2.30000092477,
+8EOK,2022-10-03,3.53,
+8EPA,2022-10-05,3.4,
+8EQA,2022-10-07,2.55,
+8EQC,2022-10-07,2.2,
+8EQF,2022-10-07,3.16,
+8ERT,2022-10-12,3.3,
+8ERX,2022-10-13,2.07,
+8ES7,2022-10-13,3.04,
+8ES8,2022-10-13,2.65,
+8ES9,2022-10-13,3.25,
+8ESA,2022-10-13,3.4,
+8ESB,2022-10-13,3.12,
+8ESH,2022-10-14,2.72,
+8ET1,2022-10-15,4.48,
+8ET2,2022-10-15,4.96,
+8EUQ,2022-10-19,3.09,
+8EVD,2022-10-20,2.0,
+8EW6,2022-10-21,1.904,
+8EZK,2022-11-01,2.3,
+8EZL,2022-11-01,2.3,
+8EZM,2022-11-01,2.1,
+8F0L,2022-11-03,1.81,
+8F2T,2022-11-08,2.12,
+8F2V,2022-11-08,3.5,
+8F5A,2022-11-12,1.95,
+8F5H,2022-11-14,2.3,
+8F5I,2022-11-14,1.9,
+8F60,2022-11-15,1.64,
+8F6L,2022-11-16,1.85,
+8F6O,2022-11-16,2.31,
+8F6U,2022-11-17,1.7,
+8F6V,2022-11-17,2.3,
+8F7M,2022-11-18,1.88,
+8F8V,2022-11-22,1.81,
+8F8W,2022-11-22,2.71,
+8F8X,2022-11-22,2.6,
+8F95,2022-11-23,2.45,
+8F9E,2022-11-23,2.95,
+8F9F,2022-11-23,2.2,
+8F9S,2022-11-24,2.1,
+8F9T,2022-11-24,1.85,
+8F9U,2022-11-24,1.7,
+8F9V,2022-11-24,2.25,
+8F9W,2022-11-24,2.4,
+8FA6,2022-11-25,2.6,
+8FA7,2022-11-25,1.8,
+8FA8,2022-11-25,1.8,
+8FA9,2022-11-25,2.45,
+8FAN,2022-11-28,2.9,
+8FAS,2022-11-28,1.55,
+8FAT,2022-11-28,2.95,
+8FB5,2022-11-29,2.9,
+8FB6,2022-11-29,2.15,
+8FB7,2022-11-29,1.75,
+8FB8,2022-11-29,1.69,
+8FBA,2022-11-29,1.96,
+8FDC,2022-12-02,1.8,
+8FDD,2022-12-02,1.54,
+8FDO,2022-12-04,2.2,
+8FEX,2022-12-06,3.07,
+8FFI,2022-12-08,2.7,
+8FG0,2022-12-11,2.36,
+8FHL,2022-12-14,2.194,
+8FHU,2022-12-15,1.801,
+8FIF,2022-12-16,2.35,
+8FJA,2022-12-19,3.0,
+8FJB,2022-12-19,3.06,
+8FLK,2022-12-21,4.0,
+8FLM,2022-12-21,2.9,
+8FM1,2022-12-22,3.16,
+8FMF,2022-12-23,2.1,
+8FMG,2022-12-23,1.79,
+8FMH,2022-12-23,1.87,
+8FML,2022-12-23,2.93,
+8FNT,2022-12-28,2.52,
+8FNU,2022-12-28,2.5,
+8FNV,2022-12-28,2.11,
+8FNW,2022-12-28,6.73,
+8FO3,2022-12-29,2.0,
+8FO4,2022-12-29,2.0,
+8FO5,2022-12-29,1.89,
+8FQ7,2023-01-05,1.4,
+8FRT,2023-01-08,1.8,
+8FTG,2023-01-12,1.13,
+8FU4,2023-01-16,1.6,
+8FVU,2023-01-19,3.6,
+8FW2,2023-01-20,3.8,
+8FW9,2023-01-20,4.46,
+8FWF,2023-01-21,1.94,
+8FWH,2023-01-22,2.833,
+8FXJ,2023-01-24,2.0,
+8FYM,2023-01-26,2.45,
+8FZ2,2023-01-27,3.5,
+8FZO,2023-01-29,1.83,
+8FZP,2023-01-29,1.63,
+8G0I,2023-01-31,2.2,
+8G19,2023-02-01,1.77,
+8G1B,2023-02-01,1.67,
+8G1C,2023-02-01,1.63,
+8G2M,2023-02-05,1.8,
+8G2O,2023-02-06,1.7,
+8G8A,2023-02-17,2.44,
+8G8C,2023-02-17,2.08,
+8G8D,2023-02-17,2.02,
+8G8N,2023-02-18,3.0,
+8G92,2023-02-21,3.6,
+8G94,2023-02-21,3.15,
+8G9W,2023-02-22,4.66,
+8G9X,2023-02-22,4.46,
+8G9Y,2023-02-22,4.28,
+8GB5,2023-02-24,3.35,
+8GB6,2023-02-24,1.75,
+8GB7,2023-02-24,2.57,
+8GB8,2023-02-24,2.3,
+8GBV,2023-02-28,2.08,
+8GBW,2023-02-28,1.5,
+8GBX,2023-02-28,2.7,
+8GBY,2023-02-28,2.35,
+8GBZ,2023-02-28,1.97,
+8GC0,2023-02-28,2.43,
+8GC1,2023-02-28,3.19,
+8GDO,2023-03-06,1.95,
+8GH4,2023-03-09,3.8,
+8GHR,2023-03-10,3.2,
+8GHZ,2023-03-13,2.78,
+8GJR,2023-03-16,1.85,
+8GJW,2023-03-16,1.93,
+8GJX,2023-03-16,2.6,
+8GJY,2023-03-16,1.5,
+8GJZ,2023-03-16,2.92,
+8GKJ,2023-03-19,1.9,
+8GKK,2023-03-19,1.75,
+8GKL,2023-03-19,2.6,
+8GLE,2023-03-22,1.85,
+8GLF,2023-03-22,2.0,
+8GLG,2023-03-22,1.6,
+8GLH,2023-03-22,1.83,
+8GLI,2023-03-22,2.1,
+8GM8,2023-03-24,2.83,
+8GO5,2022-08-24,2.809,
+8GO6,2022-08-24,2.813,
+8GO7,2022-08-24,2.303,
+8GOP,2022-08-25,2.8,
+8GPK,2022-08-26,3.34,
+8GQ1,2022-08-28,3.13,
+8GRX,2022-09-02,3.0,
+8GSI,2022-09-06,2.02,
+8GSZ,2022-09-07,3.65,
+8GT6,2022-09-07,3.47,
+8GTJ,2022-09-08,2.7,
+8GTK,2022-09-08,3.1,
+8GTN,2022-09-08,3.17,
+8GUZ,2022-09-14,1.79,
+8GV0,2022-09-14,3.192,
+8GV1,2022-09-14,1.186,
+8GV2,2022-09-14,1.274,
+8GV4,2022-09-14,2.5,
+8GVB,2022-09-14,3.2,
+8GVG,2022-09-15,3.37,
+8GVI,2022-09-15,3.3,
+8GY5,2022-09-21,1.98,
+8GYE,2022-09-22,2.3,
+8GZ6,2022-09-25,1.35,
+8H4M,2022-10-10,1.68,
+8H4O,2022-10-11,2.05,
+8H7I,2022-10-20,2.4,
+8H7M,2022-10-20,1.87,
+8H7N,2022-10-20,1.99,
+8H7R,2022-10-20,2.0,
+8H8Q,2022-10-24,2.5,
+8HB5,2022-10-27,2.6,
+8HBC,2022-10-28,3.35,
+8HGJ,2022-11-14,4.82,
+8HI1,2022-11-18,3.09,
+8HIT,2022-11-21,3.2,
+8HJJ,2022-11-23,2.4,
+8HJT,2022-11-23,2.91,
+8HLB,2022-11-29,3.63,
+8HN4,2022-12-07,2.853,
+8HNT,2022-12-08,3.06,
+8HNW,2022-12-08,3.41,
+8HR7,2022-12-15,3.96,
+8HR8,2022-12-15,3.3,
+8HR9,2022-12-15,3.03,
+8HRA,2022-12-15,3.76,
+8HRB,2022-12-15,3.78,
+8HRC,2022-12-15,2.58,
+8HRH,2022-12-15,2.07,
+8HSM,2022-12-20,2.2,
+8HSO,2022-12-20,2.1,
+8HSW,2022-12-20,2.03,
+8HT1,2022-12-20,2.4,
+8HT3,2022-12-20,2.5,
+8HT9,2022-12-20,2.2,
+8HXQ,2023-01-05,2.4,
+8HXR,2023-01-05,2.7,
+8HYL,2023-01-06,2.0,
+8I5C,2023-01-24,3.34,
+8I5D,2023-01-25,3.3,
+8I5E,2023-01-25,2.2,
+8I96,2023-02-06,3.2,
+8I9M,2023-02-07,5.19,
+8IA6,2023-02-07,2.75,
+8IA8,2023-02-08,2.86,
+8IK0,2023-02-28,3.3,
+8IK3,2023-02-28,3.3,
+8IM5,2023-03-06,,
+8IME,2023-03-06,2.63,
+8IMF,2023-03-06,2.4,
+8IMG,2023-03-06,1.8,
+8IOW,2023-03-13,3.2,
+8IQP,2023-03-17,1.76,
+8IQQ,2023-03-17,2.02,
+8IQR,2023-03-17,2.35,
+8IQS,2023-03-17,2.16,
+8IRW,2023-03-19,1.55,
+8ISN,2023-03-21,2.48,
+8J18,2023-04-12,2.89,
+8J19,2023-04-12,3.23,
+8J1A,2023-04-12,3.24,
+8J3V,2023-04-18,,
+8J4G,2023-04-19,2.49,
+8J4U,2023-04-20,2.97,
+8J6F,2023-04-25,3.3,
+8J7E,2023-04-27,2.8,
+8J8I,2023-05-01,,
+8JBA,2023-05-08,2.6,
+8JBJ,2023-05-09,1.61,
+8JBV,2023-05-09,3.02,
+8JC0,2023-05-10,3.4,
+8JCB,2023-05-10,9.5,
+8JEL,2023-05-16,2.45,
+8JEN,2023-05-16,2.71,
+8JEO,2023-05-16,2.06,
+8JEP,2023-05-16,1.7,
+8JEQ,2023-05-16,1.96,
+8JHV,2023-05-25,3.47,
+8JHW,2023-05-25,3.12,
+8JI8,2023-05-26,2.65,
+8JIB,2023-05-26,3.15,
+8JJV,2023-05-31,1.23,
+8JLY,2023-06-04,1.29,
+8JOW,2023-06-08,1.4,
+8JPS,2023-06-12,3.65,
+8JQ9,2023-06-13,2.66,
+8JQB,2023-06-13,3.2,
+8JQC,2023-06-13,3.39,
+8JQT,2023-06-14,1.99,
+8JQY,2023-06-15,3.68,
+8JQZ,2023-06-15,3.05,
+8JR4,2023-06-16,2.3,
+8JRJ,2023-06-17,2.5,
+8JRK,2023-06-17,2.3,
+8JUH,2023-06-26,2.21,
+8JV0,2023-06-27,2.2,
+8JYQ,2023-07-03,1.75,
+8JYR,2023-07-03,1.69,
+8JYV,2023-07-04,1.86,
+8JYW,2023-07-04,3.3,
+8JYX,2023-07-04,2.35,
+8JYY,2023-07-04,2.65,
+8JYZ,2023-07-04,3.63,
+8JZA,2023-07-04,1.35,
+8JZM,2023-07-05,,
+8K3Z,2023-07-17,2.81,
+8K4M,2023-07-19,1.53,
+8K5N,2023-07-22,2.2,
+8K7R,2023-07-27,3.56,
+8K7S,2023-07-27,3.51,
+8K7T,2023-07-27,3.71,
+8KAD,2023-08-02,2.0,
+8KB0,2023-08-03,2.48,
+8KB1,2023-08-03,2.46,
+8KCV,2023-08-08,2.39,
+8KEI,2023-08-11,3.56,
+8KGZ,2023-08-20,2.21,
+8OG0,2023-03-17,1.712,
+8OI2,2023-03-22,3.3,
+8OJS,2023-03-24,2.75,
+8OJT,2023-03-24,1.55,
+8OJU,2023-03-24,1.45,
+8OJV,2023-03-24,2.1,
+8OKX,2023-03-29,3.51,
+8OL1,2023-03-29,3.5,
+8OP0,2023-04-06,1.54,
+8OPI,2023-04-07,1.83,
+8OQ3,2023-04-11,2.9,
+8OR1,2023-04-12,3.5,
+8OUQ,2023-04-24,1.6,
+8OVB,2023-04-25,3.4,
+8OVQ,2023-04-26,1.61,
+8OZ3,2023-05-08,3.1,
+8OZE,2023-05-09,2.91,
+8OZG,2023-05-09,3.37,
+8OZI,2023-05-09,3.22,
+8P01,2023-05-09,2.094,
+8P1O,2023-05-12,2.17,
+8P2T,2023-05-16,1.45,
+8P43,2023-05-19,2.43,
+8P6H,2023-05-26,1.46,
+8P6I,2023-05-26,2.5,
+8P88,2023-05-31,2.022,
+8P89,2023-05-31,3.187,
+8P8Q,2023-06-02,1.792,
+8P8R,2023-06-02,1.42,
+8P8S,2023-06-02,1.17,
+8P8T,2023-06-02,1.71,
+8PE9,2023-06-13,3.152,
+8PFI,2023-06-16,2.785,
+8PII,2023-06-21,2.35,
+8PJE,2023-06-23,1.7,
+8PJF,2023-06-23,1.48,
+8PJG,2023-06-23,1.83,
+8PVQ,2023-07-18,2.43,
+8PYV,2023-07-26,1.77,
+8Q4L,2023-08-07,5.12,
+8Q5U,2023-08-09,3.0,
+8Q6K,2023-08-11,2.1,
+8Q6Q,2023-08-14,1.8,
+8Q6R,2023-08-14,1.9,
+8Q78,2023-08-15,1.225,
+8QBK,2023-08-24,2.99,
+8QBL,2023-08-24,2.66,
+8QBM,2023-08-24,3.09,
+8QEW,2023-09-01,1.2,
+8QF0,2023-09-01,1.86,
+8QF3,2023-09-02,1.25,
+8QF4,2023-09-02,1.02,
+8QF5,2023-09-02,1.5,
+8QFY,2023-09-05,2.33,
+8QGZ,2023-09-06,1.8,
+8QKR,2023-09-16,3.234,
+8QKS,2023-09-16,3.994,
+8QLO,2023-09-20,2.57,
+8QLP,2023-09-20,3.14,
+8QPX,2023-10-03,2.1,
+8QXC,2023-10-24,2.3,
+8QY4,2023-10-25,3.06,
+8QY5,2023-10-25,3.1,
+8QY6,2023-10-25,3.16,
+8QY9,2023-10-25,3.1,
+8QYA,2023-10-25,2.72,
+8QYB,2023-10-25,3.09,
+8R38,2023-11-08,1.38,
+8R3W,2023-11-10,2.38,
+8R61,2023-11-20,3.1,
+8R6Q,2023-11-22,2.17,
+8R83,2023-11-28,3.57,
+8R84,2023-11-28,3.6,
+8RAL,2023-12-01,2.1,
+8RBU,2023-12-05,2.7,
+8RBV,2023-12-05,1.8,
+8RCV,2023-12-07,1.65,
+8RDA,2023-12-07,2.29,
+8RDF,2023-12-08,2.74,
+8REF,2023-12-11,1.9,
+8REK,2023-12-11,3.05,
+8REL,2023-12-11,2.1,
+8RFH,2023-12-12,3.9,
+8RH6,2023-12-15,3.32,
+8RHQ,2023-12-16,2.0,
+8RI2,2023-12-18,2.8,
+8RJ5,2023-12-20,3.02,
+8RJH,2023-12-21,2.6,
+8RJI,2023-12-21,2.3,
+8RLT,2024-01-03,2.25,
+8RLU,2024-01-03,2.35,
+8RLV,2024-01-03,2.609,
+8RMO,2024-01-08,1.163,
+8RNE,2024-01-09,1.71,
+8RNF,2024-01-09,1.872,
+8RNG,2024-01-10,1.45,
+8RNH,2024-01-10,1.6,
+8ROO,2024-01-11,1.4,
+8ROP,2024-01-12,1.15,
+8RP8,2024-01-12,2.0,
+8RPB,2024-01-15,2.794,
+8RRO,2024-01-23,3.5,
+8RTW,2024-01-29,1.99,
+8RTX,2024-01-29,2.7,
+8RYM,2024-02-09,2.34,
+8RYN,2024-02-09,1.97,
+8RYO,2024-02-09,2.05,
+8RYP,2024-02-09,1.81,
+8RYQ,2024-02-09,2.49,
+8RZ0,2024-02-11,1.63,
+8RZ1,2024-02-11,1.75,
+8RZ2,2024-02-11,2.4,
+8S4H,2024-02-21,1.7,
+8S4K,2024-02-21,1.6,
+8S6E,2024-02-27,1.95,
+8S6Z,2024-02-28,3.05,
+8S86,2024-03-05,2.8,
+8S9H,2023-03-28,2.437,
+8SBK,2023-04-03,1.8,
+8SBL,2023-04-03,3.0,
+8SCZ,2023-04-06,3.4,
+8SD0,2023-04-06,3.8,
+8SDF,2023-04-06,1.79,
+8SDG,2023-04-06,2.71,
+8SDH,2023-04-06,2.84,
+8SEF,2023-04-09,2.47,
+8SFS,2023-04-11,2.37,
+8SFV,2023-04-11,1.83,
+8SFX,2023-04-11,1.95,
+8SFZ,2023-04-11,1.9,
+8SG3,2023-04-11,3.11,
+8SGA,2023-04-12,1.9,
+8SGB,2023-04-12,2.80001551676,
+8SGG,2023-04-12,2.03,
+8SGM,2023-04-12,2.50000221525,
+8SHI,2023-04-14,2.90001719663,
+8SHV,2023-04-14,1.58,
+8SHW,2023-04-14,1.95,
+8SI1,2023-04-14,3.2,
+8SIP,2023-04-16,1.94,
+8SIQ,2023-04-16,2.5,
+8SIR,2023-04-16,3.3,
+8SIS,2023-04-16,3.08,
+8SIT,2023-04-16,2.91,
+8SJ4,2023-04-17,2.67,
+8SJ6,2023-04-17,3.97,
+8SJA,2023-04-17,2.68,
+8SJK,2023-04-18,2.22,
+8SKK,2023-04-19,2.1,
+8SKU,2023-04-20,3.2,
+8SKV,2023-04-20,3.1,
+8SL0,2023-04-20,3.3,
+8SLC,2023-04-21,2.97,
+8SM2,2023-04-25,3.15,
+8SMK,2023-04-26,3.5,
+8SOI,2023-04-28,4.2,
+8SOR,2023-04-29,3.96,
+8SOS,2023-04-29,2.33,
+8SP0,2023-05-01,3.33,
+8SP3,2023-05-01,3.52,
+8SPB,2023-05-02,3.2,
+8SPO,2023-05-03,2.98,
+8SPQ,2023-05-03,3.26,
+8SQU,2023-05-04,3.28,
+8SQZ,2023-05-04,5.85,
+8SRM,2023-05-05,4.46,
+8SRS,2023-05-06,2.79,
+8SRZ,2023-05-08,1.25,
+8SS1,2023-05-08,1.88,
+8STL,2023-05-10,1.85,
+8SU9,2023-05-11,2.83,
+8SUB,2023-05-11,2.89,
+8SUW,2023-05-13,3.15,
+8SUX,2023-05-13,2.93,
+8SWF,2023-05-18,3.39,
+8SWK,2023-05-18,4.32,
+8SXN,2023-05-22,4.04,
+8SXX,2023-05-24,3.6,
+8T0O,2023-06-01,2.3,
+8T58,2023-06-12,2.23,
+8T64,2023-06-15,2.25,
+8T6I,2023-06-16,2.55,
+8T6M,2023-06-16,3.14,
+8T6O,2023-06-16,3.1,
+8T6P,2023-06-16,3.15,
+8T6S,2023-06-18,3.28,
+8T6T,2023-06-18,3.04,
+8T6X,2023-06-19,3.08,
+8T6Y,2023-06-19,2.88,
+8T76,2023-06-19,3.42,
+8T77,2023-06-19,3.25,
+8T78,2023-06-19,3.02,
+8T79,2023-06-20,3.04,
+8T7F,2023-06-20,3.5,
+8T7G,2023-06-20,2.0,
+8T7I,2023-06-20,2.6,
+8T7R,2023-06-21,3.84,
+8T7S,2023-06-21,3.01,
+8T8I,2023-06-22,2.52,
+8T9B,2023-06-23,4.2,
+8T9Y,2023-06-26,2.52,
+8TBB,2023-06-28,2.5,
+8TBP,2023-06-29,3.1262111426,
+8TBV,2023-06-29,2.64,
+8TBW,2023-06-29,2.081,
+8TCA,2023-06-30,2.02,
+8TCB,2023-06-30,2.69,
+8TDX,2023-07-05,2.09,
+8TE5,2023-07-05,1.502,
+8TE6,2023-07-05,1.251,
+8TE7,2023-07-05,3.18,
+8TFE,2023-07-10,1.62,
+8TFN,2023-07-11,2.54,
+8TFP,2023-07-11,1.78,
+8TFQ,2023-07-11,1.8,
+8TFR,2023-07-11,2.99,
+8TFT,2023-07-11,2.3,
+8TG9,2023-07-12,3.08,
+8TGA,2023-07-12,3.65,
+8TGT,2023-07-13,2.5,
+8TI4,2023-07-19,2.1,
+8TJF,2023-07-21,2.3,
+8TJT,2023-07-24,2.7,
+8TJY,2023-07-24,2.79,
+8TK0,2023-07-24,3.23,
+8TK1,2023-07-25,2.98,
+8TL0,2023-07-26,3.1,
+8TLZ,2023-07-27,2.75,
+8TM0,2023-07-27,3.83,
+8TM2,2023-07-27,2.85,
+8TMU,2023-07-31,2.9,
+8TN4,2023-08-01,1.4,
+8TN5,2023-08-01,1.76,
+8TN7,2023-08-01,1.56,
+8TNJ,2023-08-02,3.1,
+8TNN,2023-08-02,3.36,
+8TNT,2023-08-02,3.15,
+8TOO,2023-08-03,2.6,
+8TQ7,2023-08-06,2.8,
+8TQ8,2023-08-06,2.69,
+8TQ9,2023-08-06,2.9,
+8TQA,2023-08-06,2.6,
+8TRL,2023-08-09,2.4,
+8TRQ,2023-08-10,2.75,
+8TRR,2023-08-10,2.65,
+8TTM,2023-08-14,2.51,
+8TTY,2023-08-15,2.101,
+8TTZ,2023-08-15,3.14,
+8TUB,2023-08-16,2.4,
+8TUD,2023-08-16,3.0,
+8TUH,2023-08-16,2.20010596362,
+8TUI,2023-08-16,2.75,
+8TUZ,2023-08-17,2.186,
+8TV3,2023-08-17,2.312,
+8TW4,2023-08-20,3.3,
+8TW6,2023-08-20,3.1,
+8TYP,2023-08-25,1.8,
+8TZN,2023-08-27,3.11,
+8TZW,2023-08-28,2.66,
+8U03,2023-08-28,2.72,
+8U08,2023-08-28,1.98,
+8U70,2023-09-14,3.09,
+8U9G,2023-09-19,2.87,
+8UAE,2023-09-20,3.25,
+8UAF,2023-09-20,3.18,
+8UDR,2023-09-28,3.1,
+8UEK,2023-10-01,,
+8UH2,2023-10-06,3.59,
+8UIN,2023-10-10,3.86,
+8UIP,2023-10-10,4.3,
+8UM7,2023-10-17,,
+8UM9,2023-10-17,,
+8UMA,2023-10-17,,
+8UMB,2023-10-17,,
+8UMF,2023-10-17,2.9,
+8UMO,2023-10-18,2.6,
+8UMS,2023-10-18,,
+8UP2,2023-10-20,1.6,
+8URO,2023-10-26,3.62,
+8URV,2023-10-26,,
+8US8,2023-10-27,2.56,
+8UX6,2023-11-08,2.0,
+8UX9,2023-11-09,3.2,
+8UZC,2023-11-14,3.8,
+8V1O,2023-11-21,2.92,
+8V2E,2023-11-22,2.62,
+8V2F,2023-11-22,2.09,
+8V2L,2023-11-22,2.43,
+8V45,2023-11-28,3.63,
+8V46,2023-11-28,3.09,
+8V47,2023-11-28,4.08,
+8V48,2023-11-28,3.68,
+8V49,2023-11-28,3.62,
+8V4I,2023-11-29,1.81,
+8V4Z,2023-11-29,2.40000208775,
+8V50,2023-11-30,2.6500177696,
+8V51,2023-11-30,2.10000032944,
+8V6Q,2023-12-02,2.62,
+8V6R,2023-12-02,2.14,
+8V6S,2023-12-02,1.6,
+8V6T,2023-12-02,1.98,
+8V8K,2023-12-05,2.85,
+8VBJ,2023-12-12,1.9,
+8VBK,2023-12-12,1.89,
+8VBL,2023-12-12,2.35,
+8VBM,2023-12-12,2.54,
+8VBN,2023-12-12,1.83,
+8VBO,2023-12-12,2.3,
+8VBP,2023-12-12,2.8,
+8VBQ,2023-12-12,2.1,
+8VBR,2023-12-12,2.65,
+8VCL,2023-12-14,2.4,
+8VCX,2023-12-14,2.59,
+8VCY,2023-12-14,2.6,
+8VD0,2023-12-14,2.4,
+8VD2,2023-12-14,2.9,
+8VDD,2023-12-14,2.6,
+8VDF,2023-12-15,3.5,
+8VDG,2023-12-15,3.35,
+8VDL,2023-12-15,2.68,
+8VDU,2023-12-17,3.5,
+8VEG,2023-12-18,2.0,
+8VEV,2023-12-20,3.06,
+8VFU,2023-12-22,2.45,
+8VGE,2023-12-27,2.01,
+8VGF,2023-12-27,2.14,
+8VGG,2023-12-27,2.71,
+8VIA,2024-01-03,3.6,
+8VJZ,2024-01-08,1.9,
+8VK2,2024-01-08,2.508,
+8VLT,2024-01-12,1.84,
+8VR9,2024-01-20,3.06,
+8VRA,2024-01-20,3.12,
+8VRB,2024-01-20,3.25,
+8VRW,2024-01-22,3.03,
+8VS7,2024-01-23,2.41,
+8VS8,2024-01-23,2.67,
+8VSE,2024-01-23,3.8,
+8VSJ,2024-01-24,2.28,
+8VSP,2024-01-24,3.12,
+8VTP,2024-01-26,1.77,
+8VTR,2024-01-26,1.96,
+8VU1,2024-01-27,3.08,
+8VU4,2024-01-28,2.35,
+8VUA,2024-01-29,3.27,
+8VUC,2024-01-29,2.5,
+8VUI,2024-01-29,2.1,
+8VVM,2024-01-31,2.9,
+8VVO,2024-01-31,3.09,
+8VX9,2024-02-03,2.65,
+8VXY,2024-02-06,3.19,
+8VY4,2024-02-06,1.7,
+8VY6,2024-02-07,2.8,
+8VZ8,2024-02-11,3.45,
+8VZ9,2024-02-11,3.4,
+8W0Q,2024-02-14,,
+8W18,2024-02-15,3.94,
+8W1P,2024-02-16,3.5,
+8W2V,2024-02-21,,
+8W4L,2023-08-24,3.1,
+8W4M,2023-08-24,2.18,
+8W6L,2023-08-29,2.03,
+8W70,2023-08-30,2.5,
+8W83,2023-08-31,2.818,
+8W84,2023-08-31,2.105,
+8W85,2023-08-31,2.769,
+8W86,2023-08-31,2.236,
+8W8M,2023-09-04,3.28,
+8W8T,2023-09-04,2.3,
+8W9H,2023-09-05,2.0,
+8W9J,2023-09-05,3.5,
+8W9L,2023-09-05,3.2,
+8W9X,2023-09-06,4.4,
+8WCJ,2023-09-12,1.55,
+8WIV,2023-09-25,3.41,
+8WJ3,2023-09-25,3.36,
+8WK0,2023-09-26,3.34,
+8WKW,2023-09-28,3.21,
+8WLD,2023-09-29,3.48,
+8WM4,2023-10-02,2.93,
+8WMC,2023-10-03,2.9,
+8WMI,2023-10-03,3.53,
+8WML,2023-10-03,2.86,
+8WO1,2023-10-06,2.24,
+8WO9,2023-10-06,1.55,
+8WOC,2023-10-07,3.28,
+8WOD,2023-10-07,3.67,
+8WOF,2023-10-07,3.3,
+8WQT,2023-10-12,2.6,
+8WRX,2023-10-16,1.45,
+8WRY,2023-10-16,2.6,
+8WSA,2023-10-17,3.1,
+8WSM,2023-10-17,2.7,
+8WTA,2023-10-18,2.9,
+8WTE,2023-10-18,2.17,
+8WUL,2023-10-20,2.36,
+8WV4,2023-10-23,3.3,
+8WV5,2023-10-23,3.5,
+8WXE,2023-10-28,4.0,
+8WY0,2023-10-30,3.8,
+8WYI,2023-10-31,3.9,
+8WYR,2023-10-31,3.39,
+8WYS,2023-10-31,3.41,
+8X2O,2023-11-10,2.26,
+8X6B,2023-11-21,2.0,
+8XES,2023-12-12,1.78,
+8XFZ,2023-12-14,2.32,
+8XG2,2023-12-14,1.84,
+8XJ0,2023-12-20,3.3,
+8XS1,2024-01-08,2.3,
+8XS2,2024-01-08,2.14,
+8XUB,2024-01-12,2.5,
+8XX0,2024-01-17,2.9,
+8Y0V,2024-01-23,2.5,
+8Y0Y,2024-01-23,2.86,
+8Y13,2024-01-23,3.18,
+8Y2K,2024-01-26,2.87,
+8Y31,2024-01-28,2.68,
+8Y34,2024-01-28,3.11,
+8Y57,2024-01-31,3.2,
+8Y6X,2024-02-03,3.4,
+8Y74,2024-02-03,1.9,
+8Y81,2024-02-05,2.89,
+8Y84,2024-02-05,2.98,
+8YC0,2024-02-17,4.12,
+8YE4,2024-02-21,3.2,
+8YHO,2024-02-28,2.8,
+8YHX,2024-02-28,2.81,
+8YIV,2024-02-29,2.101,
+8YJ2,2024-02-29,2.261,
+8YJ3,2024-02-29,3.503,
+8YKF,2024-03-05,3.35,
+8YL5,2024-03-05,3.45,
+8YLN,2024-03-06,3.53,
+8YLT,2024-03-06,3.09,
+8YQF,2024-03-19,5.5,
+8YRJ,2024-03-21,3.87,
+8YTN,2024-03-26,1.72,
+8YTO,2024-03-26,1.04,
+8YTP,2024-03-26,1.36,
+8YWP,2024-03-31,2.5,
+8YWQ,2024-03-31,2.51,
+8YWR,2024-03-31,2.93,
+8YX1,2024-04-01,2.7,
+8YX9,2024-04-02,2.8,
+8Z0H,2024-04-09,1.72,
+8Z18,2024-04-10,3.94,
+8Z3K,2024-04-15,3.19,
+8Z3P,2024-04-15,3.4,
+8Z3R,2024-04-16,2.28,
+8Z40,2024-04-16,3.26,
+8Z9B,2024-04-23,2.68,
+8ZC9,2024-04-29,3.14,
+8ZCK,2024-04-30,2.0,
+8ZCL,2024-04-30,2.6,
+8ZCM,2024-04-30,2.64,
+8ZEM,2024-05-06,3.32,
+8ZEY,2024-05-07,1.734,
+8ZLU,2024-05-21,2.47,
+8ZNS,2024-05-28,2.17,
+8ZO4,2024-05-28,2.6,
+8ZOX,2024-05-29,3.18,
+8ZP7,2024-05-29,3.0,
+8ZPU,2024-05-31,2.8,
+8ZTR,2024-06-07,3.26,
+8ZV9,2024-06-11,2.6,
+8ZXW,2024-06-15,1.33,
+9ARV,2024-02-23,3.6,
+9ASF,2024-02-25,1.77,
+9ASG,2024-02-25,2.03,
+9AWX,2024-03-05,1.81,
+9AWY,2024-03-05,1.7,
+9AX1,2024-03-05,2.0,
+9AX2,2024-03-05,1.94,
+9AX3,2024-03-05,2.2,
+9AXN,2024-03-06,2.4,
+9AXO,2024-03-06,2.1,
+9AXP,2024-03-06,2.4,
+9AXQ,2024-03-06,2.2,
+9AXR,2024-03-06,3.3,
+9AXS,2024-03-06,2.04,
+9B44,2024-03-20,2.01,
+9B74,2024-03-27,2.48,
+9B75,2024-03-27,1.95,
+9B76,2024-03-27,1.73,
+9B7B,2024-03-27,3.08,
+9B8G,2024-03-29,2.66,
+9BBC,2024-04-05,3.3,
+9BD0,2024-04-10,,
+9BF1,2024-04-16,3.1,
+9BF9,2024-04-17,3.4,
+9BGE,2024-04-18,4.2,
+9BHB,2024-04-19,3.1,
+9BIF,2024-04-23,3.09,
+9BL2,2024-04-29,2.1,
+9BL3,2024-04-29,2.0,
+9BL4,2024-04-29,1.75,
+9BL5,2024-04-29,2.0,
+9BL6,2024-04-29,2.4,
+9BL9,2024-04-29,2.6,
+9BLA,2024-04-30,3.0,
+9BNS,2024-05-03,3.0,
+9BQV,2024-05-10,3.2,
+9BTX,2024-05-15,2.05,
+9BTY,2024-05-15,2.85,
+9BTZ,2024-05-15,3.0,
+9BU0,2024-05-15,2.89,
+9C3E,2024-05-31,3.5,
+9C6V,2024-06-09,1.7,
+9C6W,2024-06-09,1.7,
+9C6X,2024-06-09,1.7,
+9C79,2024-06-10,1.46,
+9C7D,2024-06-10,1.99,
+9C7F,2024-06-10,1.82,
+9C82,2024-06-11,6.84,
+9CGR,2024-06-30,2.4,
+9CGS,2024-06-30,2.0,
+9CI8,2024-07-02,3.01,
+9CIA,2024-07-03,3.39,
+9CJ0,2024-07-05,1.3,
+9CYL,2024-08-02,4.66,
+9CYM,2024-08-02,3.84,
+9D7Y,2024-08-18,2.6,
+9DH2,2024-09-03,2.98,
+9DH3,2024-09-03,3.76,
+9DKZ,2024-09-10,,
+9DL1,2024-09-10,2.3,
+9DN4,2024-09-16,1.9,
+9EQ3,2024-03-20,6.9,
+9EQ4,2024-03-20,8.4,
+9ERY,2024-03-25,2.7,
+9EZX,2024-04-14,2.55,
+9EZY,2024-04-14,2.56,
+9F18,2024-04-18,2.52,
+9F1I,2024-04-19,1.38,
+9F3V,2024-04-26,1.943,
+9F7I,2024-05-03,2.85,
+9FMB,2024-06-05,3.0,
+9FO3,2024-06-11,5.3,
+9FP6,2024-06-13,2.9,
+9FQO,2024-06-17,1.7,
+9FWW,2024-07-01,1.844,
+9FXF,2024-07-01,1.067,
+9G13,2024-07-09,1.8,
+9GU4,2024-09-18,2.696,
+9II9,2024-06-19,2.9,
+9IIE,2024-06-20,3.14,
+9IJN,2024-06-25,1.81,
+9IY0,2024-07-29,1.97,
+9IY2,2024-07-29,3.476,
+9L1S,2024-12-15,3.0,
+9MML,2024-12-20,3.67,
+9MMV,2024-12-20,3.79,
+1BZQ,1998-11-03,2.8,
+1C08,1999-07-15,2.3,
+1CBV,1993-03-16,2.66,
+1CFA,1996-09-21,,
+1DQJ,2000-01-04,2.0,
+1FNL,2000-08-22,1.8,
+1FNX,2000-08-24,,
+1G6V,2000-11-08,3.5,
+1H03,2002-06-11,1.7,
+1H04,2002-06-11,2.0,
+1H0D,2002-06-19,2.0,
+1H15,2002-07-02,3.1,
+1H2P,2002-08-13,2.8,
+1H2Q,2002-08-13,3.0,
+1HH9,2000-12-21,2.7,
+1HI6,2001-01-02,2.55,
+1HXY,2001-01-17,2.6,
+1I8M,2001-03-14,2.1,
+1I9R,2001-03-20,3.1,
+1IKF,1993-12-09,2.5,
+1J1O,2002-12-13,1.8,
+1J1P,2002-12-13,1.8,
+1J1X,2002-12-20,1.8,
+1J75,2001-05-15,1.85,
+1JTT,2001-08-22,2.1,
+1KEG,2001-11-15,2.4,
+1KLG,2001-12-11,2.4,
+1KLU,2001-12-12,1.93,
+1KXQ,2002-02-01,1.6,
+1KXT,2002-02-01,2.0,
+1KXV,2002-02-01,1.6,
+1KYJ,2002-02-04,,
+1LO5,2002-05-06,3.2,
+1NBY,2002-12-04,1.8,
+1NBZ,2002-12-04,1.85,
+1NDG,2002-12-09,1.9,
+1NDM,2002-12-09,2.1,
+1OD9,2003-02-14,2.1,
+1ODA,2003-02-14,3.31,
+1OGA,2003-04-28,1.4,
+1OLL,2003-08-07,1.93,
+1P2C,2003-04-15,2.0,
+1Q8M,2003-08-21,2.6,
+1QGC,1999-04-23,,
+1QLE,1999-08-30,3.0,
+1QLF,1999-08-30,2.65,
+1QO3,1999-11-01,2.3,
+1RI8,2003-11-17,1.85,
+1RJC,2003-11-19,1.4,
+1RVF,1996-09-05,4.0,
+1SQ2,2004-03-17,1.45,
+1SYX,2004-04-02,2.345,
+1T6V,2004-05-07,1.7,
+1UA6,2003-02-28,1.9,
+1UAC,2003-03-08,1.7,
+1UXS,2004-03-01,1.55,
+1UXW,2004-03-01,1.71,
+1V74,2003-12-10,2.0,
+1V7M,2003-12-18,2.51,
+1V7N,2003-12-18,3.3,
+1XF2,2004-09-13,2.3,
+1XFP,2004-09-15,1.5,
+1XR9,2004-10-14,1.788,
+1YY9,2005-02-24,2.605,
+1Z9S,2005-04-04,2.2,
+1ZMY,2005-05-11,3.0,
+1ZV5,2005-06-01,2.0,
+1ZVH,2005-06-02,1.5,
+1ZVY,2005-06-03,1.63,
+2AEQ,2005-07-23,3.0,
+2BNQ,2005-03-31,1.7,
+2BNR,2005-03-31,1.9,
+2BNU,2005-04-04,1.4,
+2BSR,2005-05-23,2.3,
+2BSS,2005-05-23,2.0,
+2BST,2005-05-23,2.1,
+2CII,2006-03-21,2.55,
+2CIK,2006-03-22,1.75,
+2DQC,2006-05-25,1.8,
+2DQD,2006-05-25,1.8,
+2DQE,2006-05-25,1.9,
+2DQF,2006-05-25,2.5,
+2DQG,2006-05-25,2.3,
+2DQH,2006-05-26,2.3,
+2DQI,2006-05-26,2.0,
+2DQJ,2006-05-26,1.8,
+2EIZ,2007-03-14,1.9,
+2EKS,2007-03-24,2.0,
+2EQI,2007-03-30,,
+2ERJ,2005-10-25,3.0,
+2FD6,2005-12-13,1.9,
+2FHZ,2005-12-27,1.15,
+2FR4,2006-01-18,1.95,
+2H3A,2006-05-22,,
+2H3C,2006-05-22,,
+2H9G,2006-06-09,2.32,
+2HEO,2006-06-21,1.7,
+2HMI,1998-04-10,2.8,
+2JIX,2007-07-02,3.2,
+2K5X,2008-07-01,,
+2KH2,2009-03-23,,
+2M94,2013-05-31,,
+2NR6,2006-11-01,2.81,
+2NTS,2006-11-08,2.4,
+2NYY,2006-11-21,2.61,
+2NZ9,2006-11-22,3.79,
+2OK0,2007-01-15,1.89,
+2P42,2007-03-11,1.8,
+2P43,2007-03-11,1.65,
+2P44,2007-03-11,1.8,
+2P45,2007-03-11,1.1,
+2P46,2007-03-11,2.5,
+2P47,2007-03-11,2.5,
+2P48,2007-03-11,2.3,
+2P49,2007-03-11,1.38,
+2P4A,2007-03-11,1.9,
+2R0K,2007-08-20,3.51,
+2R0L,2007-08-20,2.2,
+2R6P,2007-09-06,24.0,
+2R8S,2007-09-11,1.95,
+2VGQ,2007-11-15,2.1,
+2VSD,2008-04-22,1.82,
+2WUB,2009-10-01,2.9,
+2XXM,2010-11-10,1.65,
+2YBR,2011-03-09,2.55,
+2YC1,2011-03-10,1.9,
+2YSS,2007-04-03,2.4,
+2ZNW,2008-05-02,2.71,
+2ZNX,2008-05-02,2.3,
+2ZUQ,2008-10-28,3.3,
+3A67,2009-08-24,1.8,
+3A6B,2009-08-28,1.8,
+3A6C,2009-08-28,1.8,
+3AGV,2010-04-08,2.15,
+3B2U,2007-10-19,2.58,
+3B2V,2007-10-19,3.3,
+3B5T,2007-10-26,1.75,
+3BDW,2007-11-15,2.5,
+3C09,2008-01-18,3.2,
+3CIY,2008-03-12,3.41,
+3D85,2008-05-22,1.9,
+3D9A,2008-05-27,1.2,
+3DUH,2008-07-17,2.3,
+3EBA,2008-08-27,1.85,
+3EHB,2008-09-12,2.32,
+3EO1,2008-09-26,3.1,
+3ETB,2008-10-07,3.8,
+3F8U,2008-11-13,2.6,
+3FFD,2008-12-03,2.0,
+3G3A,2009-02-02,2.2,
+3G3B,2009-02-02,2.4,
+3GRW,2009-03-26,2.1,
+3H42,2009-04-17,2.3,
+3HMX,2009-05-29,3.0,
+3IVK,2009-09-01,3.1,
+3J1S,2012-05-23,8.5,
+3J3O,2013-04-10,11.1,
+3J3P,2013-04-10,9.1,
+3J42,2013-06-13,21.0,
+3J6U,2014-03-26,9.0,
+3J8D,2014-10-13,26.0,
+3J8V,2014-11-19,13.9,
+3J8W,2014-11-19,13.0,
+3J8Z,2014-11-20,14.0,
+3JAB,2015-05-26,11.0,
+3JAU,2015-06-24,4.8,
+3JBA,2015-08-11,12.0,
+3JBC,2015-08-26,6.5,
+3JBD,2015-08-26,4.8,
+3JBE,2015-08-26,4.2,
+3JBF,2015-08-26,4.8,
+3JBG,2015-08-26,3.8,
+3JBQ,2015-09-17,11.0,
+3JCX,2016-03-21,4.1,
+3K2U,2009-09-30,2.35,
+3KPQ,2009-11-16,1.84,
+3LIZ,2010-01-25,1.8,
+3M17,2010-03-04,2.6,
+3M1B,2010-03-04,3.1,
+3MFG,2010-04-02,2.37,
+3MOQ,2010-04-23,2.054,
+3N85,2010-05-27,3.2,
+3NFP,2010-06-10,2.86,
+3NPS,2010-06-29,1.5,
+3O0R,2010-07-20,2.7,
+3OPZ,2010-09-02,3.4,
+3PRX,2010-11-30,4.3,
diff --git a/notebooks/immune_system_pdb_report_deposition_date.png b/notebooks/immune_system_pdb_report_deposition_date.png
new file mode 100644
index 00000000..b695c2bb
Binary files /dev/null and b/notebooks/immune_system_pdb_report_deposition_date.png differ
diff --git a/notebooks/immune_system_pdb_report_resolution.png b/notebooks/immune_system_pdb_report_resolution.png
new file mode 100644
index 00000000..04d8d8d2
Binary files /dev/null and b/notebooks/immune_system_pdb_report_resolution.png differ
diff --git a/notebooks/posebusters_benchmark_inference_results_plotting.ipynb b/notebooks/posebusters_benchmark_inference_results_plotting.ipynb
index 95acb197..b1cb48c4 100644
--- a/notebooks/posebusters_benchmark_inference_results_plotting.ipynb
+++ b/notebooks/posebusters_benchmark_inference_results_plotting.ipynb
@@ -68,6 +68,8 @@
" \"rfaa\",\n",
" \"chai-lab_ss\",\n",
" \"chai-lab\",\n",
+ " \"boltz_ss\",\n",
+ " \"boltz\",\n",
" \"alphafold3_ss\",\n",
" \"alphafold3\",\n",
"]\n",
@@ -103,6 +105,7 @@
"globals()[\"neuralplexer_output_dir\"] = os.path.join(\"..\", \"forks\", \"NeuralPLexer\", \"inference\")\n",
"globals()[\"rfaa_output_dir\"] = os.path.join(\"..\", \"forks\", \"RoseTTAFold-All-Atom\", \"inference\")\n",
"globals()[\"chai-lab_output_dir\"] = os.path.join(\"..\", \"forks\", \"chai-lab\", \"inference\")\n",
+ "globals()[\"boltz_output_dir\"] = os.path.join(\"..\", \"forks\", \"boltz\", \"inference\")\n",
"globals()[\"alphafold3_output_dir\"] = os.path.join(\"..\", \"forks\", \"alphafold3\", \"inference\")\n",
"for repeat_index in range(1, max_num_repeats_per_method + 1):\n",
" # PLIF metrics\n",
@@ -206,6 +209,34 @@
" )\n",
" )\n",
"\n",
+ " # Boltz (Single-Seq) results\n",
+ " globals()[f\"boltz_ss_posebusters_bust_results_csv_filepath_{repeat_index}\"] = os.path.join(\n",
+ " globals()[\"boltz_output_dir\"],\n",
+ " f\"boltz_ss_posebusters_benchmark_outputs_{repeat_index}\",\n",
+ " \"bust_results.csv\",\n",
+ " )\n",
+ " globals()[f\"boltz_ss_posebusters_relaxed_bust_results_csv_filepath_{repeat_index}\"] = (\n",
+ " os.path.join(\n",
+ " globals()[\"boltz_output_dir\"],\n",
+ " f\"boltz_ss_posebusters_benchmark_outputs_{repeat_index}_relaxed\",\n",
+ " \"bust_results.csv\",\n",
+ " )\n",
+ " )\n",
+ "\n",
+ " # Boltz results\n",
+ " globals()[f\"boltz_posebusters_bust_results_csv_filepath_{repeat_index}\"] = os.path.join(\n",
+ " globals()[\"boltz_output_dir\"],\n",
+ " f\"boltz_posebusters_benchmark_outputs_{repeat_index}\",\n",
+ " \"bust_results.csv\",\n",
+ " )\n",
+ " globals()[f\"boltz_posebusters_relaxed_bust_results_csv_filepath_{repeat_index}\"] = (\n",
+ " os.path.join(\n",
+ " globals()[\"boltz_output_dir\"],\n",
+ " f\"boltz_posebusters_benchmark_outputs_{repeat_index}_relaxed\",\n",
+ " \"bust_results.csv\",\n",
+ " )\n",
+ " )\n",
+ "\n",
" # AlphaFold 3 (Single-Seq) results\n",
" globals()[f\"alphafold3_ss_posebusters_bust_results_csv_filepath_{repeat_index}\"] = (\n",
" os.path.join(\n",
@@ -245,6 +276,8 @@
" \"rfaa\": \"RFAA\",\n",
" \"chai-lab_ss\": \"Chai-1-Single-Seq\",\n",
" \"chai-lab\": \"Chai-1\",\n",
+ " \"boltz_ss\": \"Boltz-1-Single-Seq\",\n",
+ " \"boltz\": \"Boltz-1\",\n",
" \"alphafold3_ss\": \"AF3-Single-Seq\",\n",
" \"alphafold3\": \"AF3\",\n",
"}\n",
@@ -257,6 +290,8 @@
" \"rfaa\": \"DL-based blind\",\n",
" \"chai-lab_ss\": \"DL-based blind\",\n",
" \"chai-lab\": \"DL-based blind\",\n",
+ " \"boltz_ss\": \"DL-based blind\",\n",
+ " \"boltz\": \"DL-based blind\",\n",
" \"alphafold3_ss\": \"DL-based blind\",\n",
" \"alphafold3\": \"DL-based blind\",\n",
"}"
@@ -562,7 +597,7 @@
"colors = [\"#AB8042\", \"#FB8072\", \"#BEBADA\", \"#FCCDE5\"]\n",
"\n",
"bar_width = 0.5\n",
- "r1 = [item - 0.5 for item in range(2, 20, 2)]\n",
+ "r1 = [item - 0.5 for item in range(2, 24, 2)]\n",
"r2 = [x + bar_width for x in r1]\n",
"r3 = [x + bar_width for x in r2]\n",
"\n",
@@ -954,7 +989,7 @@
"\n",
"# add labels, titles, ticks, etc.\n",
"axis.set_ylabel(\"Percentage of predictions\")\n",
- "axis.set_xlim(1, 19 + 0.1)\n",
+ "axis.set_xlim(1, 23 + 0.1)\n",
"axis.set_ylim(0, 150)\n",
"\n",
"assert all(\n",
@@ -1100,7 +1135,7 @@
"axis.grid(axis=\"y\", color=\"#EAEFF8\")\n",
"axis.set_axisbelow(True)\n",
"\n",
- "axis.set_xticks([2, 2 + 1e-3, 4, 6, 8, 10, 11, 12, 14, 16, 18])\n",
+ "axis.set_xticks([2, 2 + 1e-3, 4, 6, 8, 10, 12, 13, 14, 16, 18, 20, 22])\n",
"axis.set_xticks([1 + 0.1], minor=True)\n",
"axis.set_xticklabels(\n",
" [\n",
@@ -1110,9 +1145,11 @@
" \"DynamicBind\",\n",
" \"NeuralPLexer\",\n",
" \"RFAA\",\n",
- " \"DL-based blind\",\n",
" \"Chai-1-Single-Seq\",\n",
+ " \"DL-based blind\",\n",
" \"Chai-1\",\n",
+ " \"Boltz-1-Single-Seq\",\n",
+ " \"Boltz-1\",\n",
" \"AF3-Single-Seq\",\n",
" \"AF3\",\n",
" ]\n",
@@ -1126,7 +1163,7 @@
"axis.tick_params(axis=\"y\", which=\"major\", left=\"off\", right=\"on\", color=\"#EAEFF8\")\n",
"\n",
"# vertical alignment of xtick labels\n",
- "vert_alignments = [0.0, -0.1, 0.0, 0.0, 0.0, 0.0, -0.1, 0.0, 0.0, 0.0, 0.0]\n",
+ "vert_alignments = [0.0, -0.1, 0.0, 0.0, 0.0, 0.0, 0.0, -0.1, 0.0, 0.0, 0.0, 0.0, 0.0]\n",
"for tick, y in zip(axis.get_xticklabels(), vert_alignments):\n",
" tick.set_y(y)\n",
"\n",
diff --git a/notebooks/posebusters_benchmark_method_interaction_analysis.png b/notebooks/posebusters_benchmark_method_interaction_analysis.png
new file mode 100644
index 00000000..6f53c673
Binary files /dev/null and b/notebooks/posebusters_benchmark_method_interaction_analysis.png differ
diff --git a/notebooks/posebusters_benchmark_methods_generalization_analysis.png b/notebooks/posebusters_benchmark_methods_generalization_analysis.png
new file mode 100644
index 00000000..f9217ac3
Binary files /dev/null and b/notebooks/posebusters_benchmark_methods_generalization_analysis.png differ
diff --git a/notebooks/posebusters_benchmark_plif_emd_values.png b/notebooks/posebusters_benchmark_plif_emd_values.png
new file mode 100644
index 00000000..178233c3
Binary files /dev/null and b/notebooks/posebusters_benchmark_plif_emd_values.png differ
diff --git a/notebooks/posebusters_benchmark_plif_metrics.csv b/notebooks/posebusters_benchmark_plif_metrics.csv
new file mode 100644
index 00000000..296283be
--- /dev/null
+++ b/notebooks/posebusters_benchmark_plif_metrics.csv
@@ -0,0 +1,3389 @@
+,Category,Target,EMD,WM,Method_Histogram,Reference_Histogram
+0,P2Rank-Vina,8AAU_LH0,0.19047619047619052,0.9238095238095237,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1,P2Rank-Vina,7JHQ_VAJ,,0.0,,
+2,P2Rank-Vina,6ZCY_QF8,0.07692307692307687,0.9692307692307692,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+3,P2Rank-Vina,7UAW_MF6,0.75,0.7,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+4,P2Rank-Vina,6YMS_OZH,,0.0,,
+5,P2Rank-Vina,7UJ5_DGL,,0.0,,
+6,P2Rank-Vina,8EX2_Q2Q,0.08333333333333334,0.9666666666666667,"{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1}","{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+7,P2Rank-Vina,7R9N_F97,0.055555555555555525,0.9777777777777777,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+8,P2Rank-Vina,7UYB_OK0,,0.0,,
+9,P2Rank-Vina,7U0U_FK5,,0.0,,
+10,P2Rank-Vina,7ZU2_DHT,0.4,0.84,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+11,P2Rank-Vina,6XHT_V2V,,0.0,,
+12,P2Rank-Vina,7OSO_0V1,,0.0,,
+13,P2Rank-Vina,8D19_GSH,0.5333333333333332,0.7866666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+14,P2Rank-Vina,7MGT_ZD4,0.47826086956521746,0.808695652173913,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+15,P2Rank-Vina,8C3N_ADP,0.12499999999999994,0.9500000000000001,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+16,P2Rank-Vina,6YYO_Q1K,,0.0,,
+17,P2Rank-Vina,8A1H_DLZ,,0.0,,
+18,P2Rank-Vina,7XQZ_FPF,0.22727272727272727,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+19,P2Rank-Vina,7RH3_59O,0.21052631578947373,0.9157894736842105,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+20,P2Rank-Vina,7OMX_CNA,0.09677419354838718,0.9612903225806452,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+21,P2Rank-Vina,7LMO_NYO,0.3333333333333333,0.8666666666666667,"{'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+22,P2Rank-Vina,7VBU_6I4,0.45,0.8200000000000001,"{'UNL:CYS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+23,P2Rank-Vina,7TXK_LW8,,0.0,,
+24,P2Rank-Vina,7T1D_E7K,,0.0,,
+25,P2Rank-Vina,7R59_I5F,0.0,1.0,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+26,P2Rank-Vina,7ZCC_OGA,,0.0,,
+27,P2Rank-Vina,7V43_C4O,,0.0,,
+28,P2Rank-Vina,7BNH_BEZ,,0.0,,
+29,P2Rank-Vina,6WTN_RXT,0.5625,0.775,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+30,P2Rank-Vina,7QFM_AY3,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+31,P2Rank-Vina,7MSR_DCA,,0.0,,
+32,P2Rank-Vina,5SAK_ZRY,0.7857142857142856,0.6857142857142857,"{'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+33,P2Rank-Vina,7QTA_URI,,0.0,,
+34,P2Rank-Vina,7RSV_7IQ,,0.0,,
+35,P2Rank-Vina,8DSC_NCA,,0.0,,
+36,P2Rank-Vina,7AKL_RK5,0.15000000000000008,0.94,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+37,P2Rank-Vina,7XBV_APC,0.5789473684210527,0.7684210526315789,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+38,P2Rank-Vina,7CNS_PMV,0.55,0.78,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+39,P2Rank-Vina,7ZDY_6MJ,0.4444444444444444,0.8222222222222222,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+40,P2Rank-Vina,6Z4N_Q7B,,0.0,,
+41,P2Rank-Vina,7NFB_GEN,,0.0,,
+42,P2Rank-Vina,7R7R_AWJ,0.4117647058823529,0.8352941176470589,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+43,P2Rank-Vina,7V14_ORU,0.38888888888888895,0.8444444444444444,"{'UNL:ALA:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+44,P2Rank-Vina,6YR2_T1C,,0.0,,
+45,P2Rank-Vina,7JG0_GAR,0.2857142857142857,0.8857142857142857,"{'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:V:VdWContact': 1}"
+46,P2Rank-Vina,7EBG_J0L,1.0769230769230769,0.5692307692307692,"{'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+47,P2Rank-Vina,8AY3_OE3,,0.0,,
+48,P2Rank-Vina,7M6K_YRJ,,0.0,,
+49,P2Rank-Vina,6YT6_PKE,0.29999999999999993,0.88,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+50,P2Rank-Vina,7Q27_8KC,,0.0,,
+51,P2Rank-Vina,8DHG_T78,,0.0,,
+52,P2Rank-Vina,8EXL_799,,0.0,,
+53,P2Rank-Vina,7FB7_8NF,,0.0,,
+54,P2Rank-Vina,7THI_PGA,0.3571428571428572,0.8571428571428571,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+55,P2Rank-Vina,6ZAE_ACV,0.18181818181818182,0.9272727272727272,"{'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+56,P2Rank-Vina,7MGY_ZD1,,0.0,,
+57,P2Rank-Vina,7XPO_UPG,,0.0,,
+58,P2Rank-Vina,7SUC_COM,,0.0,,
+59,P2Rank-Vina,7BJJ_TVW,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+60,P2Rank-Vina,7K0V_VQP,0.923076923076923,0.6307692307692307,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+61,P2Rank-Vina,7TE8_P0T,0.3478260869565217,0.8608695652173913,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 3, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+62,P2Rank-Vina,7QF4_RBF,0.380952380952381,0.8476190476190476,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+63,P2Rank-Vina,7UJ4_OQ4,0.28571428571428564,0.8857142857142858,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+64,P2Rank-Vina,7A9H_TPP,0.19230769230769224,0.9230769230769231,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+65,P2Rank-Vina,7LEV_0JO,,0.0,,
+66,P2Rank-Vina,7N6F_0I1,,0.0,,
+67,P2Rank-Vina,8EAB_VN2,,0.0,,
+68,P2Rank-Vina,6ZC3_JOR,,0.0,,
+69,P2Rank-Vina,7Q25_8J9,,0.0,,
+70,P2Rank-Vina,7C3U_AZG,0.4666666666666666,0.8133333333333334,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2}"
+71,P2Rank-Vina,7ROR_69X,,0.0,,
+72,P2Rank-Vina,7MMH_ZJY,,0.0,,
+73,P2Rank-Vina,7TH4_FFO,,0.0,,
+74,P2Rank-Vina,8D39_QDB,,0.0,,
+75,P2Rank-Vina,7YZU_DO7,0.27777777777777773,0.888888888888889,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+76,P2Rank-Vina,5SB2_1K2,0.517241379310345,0.793103448275862,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+77,P2Rank-Vina,6M73_FNR,,0.0,,
+78,P2Rank-Vina,8B8H_OJQ,0.09677419354838712,0.9612903225806452,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+79,P2Rank-Vina,7TOM_5AD,,0.0,,
+80,P2Rank-Vina,7VWF_K55,,0.0,,
+81,P2Rank-Vina,7XI7_4RI,0.13333333333333341,0.9466666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+82,P2Rank-Vina,7AN5_RDH,0.49999999999999994,0.8,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+83,P2Rank-Vina,7B2C_TP7,,0.0,,
+84,P2Rank-Vina,7B94_ANP,,0.0,,
+85,P2Rank-Vina,7NF0_BYN,,0.0,,
+86,P2Rank-Vina,7WKL_CAQ,0.4375,0.825,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 3, 'UNL:ASN:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+87,P2Rank-Vina,7WPW_F15,,0.0,,
+88,P2Rank-Vina,8SLG_G5A,,0.0,,
+89,P2Rank-Vina,7RNI_60I,,0.0,,
+90,P2Rank-Vina,7SZA_DUI,0.21052631578947367,0.9157894736842105,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+91,P2Rank-Vina,7PIH_7QW,0.17391304347826086,0.9304347826086956,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+92,P2Rank-Vina,7T3E_SLB,0.7058823529411764,0.7176470588235294,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+93,P2Rank-Vina,7FRX_O88,,0.0,,
+94,P2Rank-Vina,8CNH_V6U,,0.0,,
+95,P2Rank-Vina,7C8Q_DSG,0.7500000000000001,0.7,"{'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:DSG:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+96,P2Rank-Vina,7ZF0_DHR,,0.0,,
+97,P2Rank-Vina,8G0V_YHT,0.36363636363636354,0.8545454545454546,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+98,P2Rank-Vina,7P5T_5YG,,0.0,,
+99,P2Rank-Vina,7NU0_DCL,,0.0,,
+100,P2Rank-Vina,6Z0R_Q4H,0.5714285714285714,0.7714285714285715,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}"
+101,P2Rank-Vina,7XRL_FWK,,0.0,,
+102,P2Rank-Vina,7LOU_IFM,,0.0,,
+103,P2Rank-Vina,7ROU_66I,,0.0,,
+104,P2Rank-Vina,6XCT_478,,0.0,,
+105,P2Rank-Vina,7LT0_ONJ,0.3500000000000001,0.86,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+106,P2Rank-Vina,7OLI_8HG,,0.0,,
+107,P2Rank-Vina,7Z1Q_NIO,0.5,0.8,"{'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+108,P2Rank-Vina,6YQW_82I,0.23076923076923067,0.9076923076923077,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+109,P2Rank-Vina,6T88_MWQ,,0.0,,
+110,P2Rank-Vina,7PRI_7TI,,0.0,,
+111,P2Rank-Vina,7OFF_VCB,,0.0,,
+112,P2Rank-Vina,7DQL_4CL,0.6666666666666666,0.7333333333333334,"{'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+113,P2Rank-Vina,7O1T_5X8,,0.0,,
+114,P2Rank-Vina,7KM8_WPD,,0.0,,
+115,P2Rank-Vina,7ZXV_45D,0.23076923076923078,0.9076923076923077,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 5, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL::Hydrophobic': 1, 'UNL::VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+116,P2Rank-Vina,7X5N_5M5,,0.0,,
+117,P2Rank-Vina,7VQ9_ISY,,0.0,,
+118,P2Rank-Vina,7PJQ_OWH,0.2666666666666666,0.8933333333333333,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+119,P2Rank-Vina,8AQL_PLG,,0.0,,
+120,P2Rank-Vina,7VC5_9SF,,0.0,,
+121,P2Rank-Vina,7AFX_R9K,,0.0,,
+122,P2Rank-Vina,7RKW_5TV,,0.0,,
+123,P2Rank-Vina,7TYP_KUR,0.4782608695652173,0.808695652173913,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+124,P2Rank-Vina,7L03_F9F,,0.0,,
+125,P2Rank-Vina,7P1F_KFN,,0.0,,
+126,P2Rank-Vina,7O0N_CDP,,0.0,,
+127,P2Rank-Vina,7MYU_ZR7,0.3181818181818181,0.8727272727272728,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+128,P2Rank-Vina,6YSP_PAL,1.125,0.55,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+129,P2Rank-Vina,7XJN_NSD,,0.0,,
+130,P2Rank-Vina,7R6J_2I7,,0.0,,
+131,P2Rank-Vina,8HFN_XGC,0.46153846153846156,0.8153846153846154,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+132,P2Rank-Vina,7BTT_F8R,0.23529411764705888,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+133,P2Rank-Vina,7MY1_IPE,0.2,0.92,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+134,P2Rank-Vina,8FO5_Y4U,0.4000000000000001,0.84,"{'UNL:GLU:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}"
+135,P2Rank-Vina,8AUH_L9I,,0.0,,
+136,P2Rank-Vina,7ECR_SIN,,0.0,,
+137,P2Rank-Vina,6TW5_9M2,,0.0,,
+138,P2Rank-Vina,7ELT_TYM,0.59375,0.7625,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}"
+139,P2Rank-Vina,7D5C_GV6,,0.0,,
+140,P2Rank-Vina,7W06_ITN,0.375,0.85,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+141,P2Rank-Vina,6YJA_2BA,,0.0,,
+142,P2Rank-Vina,7P1M_4IU,0.23809523809523808,0.9047619047619048,"{'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+143,P2Rank-Vina,7PGX_FMN,,0.0,,
+144,P2Rank-Vina,7UAS_MBU,0.3888888888888888,0.8444444444444446,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+145,P2Rank-Vina,8GFD_ZHR,0.11111111111111116,0.9555555555555555,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+146,P2Rank-Vina,7CTM_BDP,,0.0,,
+147,P2Rank-Vina,7UQ3_O2U,0.6666666666666667,0.7333333333333333,"{'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+148,P2Rank-Vina,7DKT_GLF,,0.0,,
+149,P2Rank-Vina,7CNQ_G8X,,0.0,,
+150,P2Rank-Vina,6Z1C_7EY,0.6,0.76,"{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}"
+151,P2Rank-Vina,7M3H_YPV,0.1428571428571429,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1}"
+152,P2Rank-Vina,7D6O_MTE,,0.0,,
+153,P2Rank-Vina,7N4W_P4V,0.28571428571428564,0.8857142857142858,"{'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+154,P2Rank-Vina,6Z2C_Q5E,0.4166666666666667,0.8333333333333333,"{'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+155,P2Rank-Vina,7CIJ_G0C,0.2,0.92,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2}"
+156,P2Rank-Vina,7USH_82V,,0.0,,
+157,P2Rank-Vina,7XG5_PLP,0.5625,0.775,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+158,P2Rank-Vina,7PT3_3KK,,0.0,,
+159,P2Rank-Vina,7KB1_WBJ,,0.0,,
+160,P2Rank-Vina,7WUX_6OI,0.2941176470588236,0.8823529411764706,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}"
+161,P2Rank-Vina,7OZ9_NGK,0.33333333333333326,0.8666666666666667,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+162,P2Rank-Vina,7N03_ZRP,0.5238095238095238,0.7904761904761904,"{'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+163,P2Rank-Vina,7BMI_U4B,0.13333333333333333,0.9466666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+164,P2Rank-Vina,7RZL_NPO,,0.0,,
+165,P2Rank-Vina,7QHL_D5P,,0.0,,
+166,P2Rank-Vina,7N7B_T3F,,0.0,,
+167,P2Rank-Vina,7Q5I_I0F,,0.0,,
+168,P2Rank-Vina,7BKA_4JC,,0.0,,
+169,P2Rank-Vina,7NXO_UU8,0.5882352941176472,0.7647058823529411,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+170,P2Rank-Vina,6XG5_TOP,,0.0,,
+171,P2Rank-Vina,6XBO_5MC,,0.0,,
+172,P2Rank-Vina,8DKO_TFB,,0.0,,
+173,P2Rank-Vina,7LJN_GTP,0.17391304347826086,0.9304347826086956,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+174,P2Rank-Vina,7MOI_HPS,0.5294117647058825,0.788235294117647,"{'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}"
+175,P2Rank-Vina,8G6P_API,,0.0,,
+176,P2Rank-Vina,7ULC_56B,0.5185185185185185,0.7925925925925926,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+177,P2Rank-Vina,7RC3_SAH,,0.0,,
+178,P2Rank-Vina,7SFO_98L,0.4999999999999999,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+179,P2Rank-Vina,8DP2_UMA,,0.0,,
+180,P2Rank-Vina,7ZZW_KKW,,0.0,,
+181,P2Rank-Vina,7XFA_D9J,0.14285714285714296,0.9428571428571428,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+182,P2Rank-Vina,7NP6_UK8,0.35483870967741926,0.8580645161290323,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+183,P2Rank-Vina,7F5D_EUO,0.2777777777777777,0.888888888888889,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+184,P2Rank-Vina,6TW7_NZB,,0.0,,
+185,P2Rank-Vina,7FHA_ADX,0.6190476190476191,0.7523809523809524,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+186,P2Rank-Vina,7ES1_UDP,0.35,0.86,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+187,P2Rank-Vina,7OEO_V9Z,0.13636363636363638,0.9454545454545454,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+188,P2Rank-Vina,7DUA_HJ0,0.6499999999999999,0.74,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+189,P2Rank-Vina,7BCP_GCO,0.05882352941176472,0.9764705882352941,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+190,P2Rank-Vina,7P2I_MFU,,0.0,,
+191,P2Rank-Vina,7WDT_NGS,0.28571428571428575,0.8857142857142857,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+192,P2Rank-Vina,8AEM_LVF,,0.0,,
+193,P2Rank-Vina,7WY1_D0L,,0.0,,
+194,P2Rank-Vina,7KRU_ATP,,0.0,,
+195,P2Rank-Vina,7P4C_5OV,,0.0,,
+196,P2Rank-Vina,7MWN_WI5,,0.0,,
+197,P2Rank-Vina,7ZHP_IQY,,0.0,,
+198,P2Rank-Vina,7W05_GMP,0.4666666666666667,0.8133333333333334,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+199,P2Rank-Vina,7UJF_R3V,0.4285714285714284,0.8285714285714286,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 8, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+200,P2Rank-Vina,7LOE_Y84,0.5714285714285714,0.7714285714285715,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+201,P2Rank-Vina,8AIE_M7L,1.0,0.6,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+202,P2Rank-Vina,7JY3_VUD,,0.0,,
+203,P2Rank-Vina,6XM9_V55,,0.0,,
+204,P2Rank-Vina,7POM_7VZ,0.21052631578947367,0.9157894736842105,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+205,P2Rank-Vina,7M31_TDR,,0.0,,
+206,P2Rank-Vina,8EYE_X4I,,0.0,,
+207,P2Rank-Vina,6YRV_PJ8,,0.0,,
+208,P2Rank-Vina,7LZD_YHY,,0.0,,
+209,P2Rank-Vina,7EPV_FDA,,0.0,,
+210,P2Rank-Vina,7UY4_SMI,,0.0,,
+211,P2Rank-Vina,7N4N_0BK,,0.0,,
+212,P2Rank-Vina,7UMW_NAD,,0.0,,
+213,P2Rank-Vina,7U3J_L6U,0.4482758620689655,0.8206896551724138,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+214,P2Rank-Vina,6Z14_Q4Z,,0.0,,
+215,P2Rank-Vina,6ZK5_IMH,0.20000000000000004,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+216,P2Rank-Vina,7QGP_DJ8,0.8421052631578948,0.6631578947368421,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+217,P2Rank-Vina,7L5F_XNG,0.6842105263157894,0.7263157894736842,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+218,P2Rank-Vina,7FT9_4MB,,0.0,,
+219,P2Rank-Vina,7OP9_06K,,0.0,,
+220,P2Rank-Vina,7JXX_VP7,,0.0,,
+221,P2Rank-Vina,7CL8_TES,,0.0,,
+222,P2Rank-Vina,7TM6_GPJ,,0.0,,
+223,P2Rank-Vina,7WQQ_5Z6,0.6,0.76,"{'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+224,P2Rank-Vina,7WL4_JFU,0.09523809523809523,0.9619047619047619,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+225,P2Rank-Vina,7SCW_GSP,0.39999999999999997,0.8400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+226,P2Rank-Vina,7L7C_XQ1,,0.0,,
+227,P2Rank-Vina,7PUV_84Z,,0.0,,
+228,P2Rank-Vina,7KQU_YOF,,0.0,,
+229,P2Rank-Vina,7Z2O_IAJ,0.2631578947368421,0.8947368421052632,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+230,P2Rank-Vina,7PRM_81I,0.608695652173913,0.7565217391304349,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+231,P2Rank-Vina,8FLV_ZB9,0.5714285714285714,0.7714285714285715,"{'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+232,P2Rank-Vina,7NLV_UJE,0.4545454545454547,0.8181818181818181,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+233,P2Rank-Vina,7T0D_FPP,,0.0,,
+234,P2Rank-Vina,7MWU_ZPM,,0.0,,
+235,P2Rank-Vina,7L00_XCJ,,0.0,,
+236,P2Rank-Vina,8C5M_MTA,,0.0,,
+237,P2Rank-Vina,7Z7F_IF3,,0.0,,
+238,P2Rank-Vina,7TSF_H4B,,0.0,,
+239,P2Rank-Vina,7TUO_KL9,0.18518518518518517,0.9259259259259259,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+240,P2Rank-Vina,7ED2_A3P,0.5789473684210525,0.768421052631579,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+241,P2Rank-Vina,7ZL5_IWE,,0.0,,
+242,P2Rank-Vina,8F8E_XJI,0.36363636363636365,0.8545454545454545,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+243,P2Rank-Vina,7OZC_G6S,0.44444444444444453,0.8222222222222222,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+244,P2Rank-Vina,7Q2B_M6H,0.1538461538461539,0.9384615384615385,"{'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+245,P2Rank-Vina,6VTA_AKN,,0.0,,
+246,P2Rank-Vina,7V3N_AKG,0.44444444444444453,0.8222222222222222,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+247,P2Rank-Vina,8F4J_PHO,,0.0,,
+248,P2Rank-Vina,7ZOC_T8E,0.23529411764705882,0.9058823529411765,"{'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+249,P2Rank-Vina,7WCF_ACP,0.375,0.85,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+250,P2Rank-Vina,7NUT_GLP,0.1875,0.925,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}"
+251,P2Rank-Vina,7E4L_MDN,0.49999999999999994,0.8,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+252,P2Rank-Vina,7TS6_KMI,,0.0,,
+253,P2Rank-Vina,7NF3_4LU,,0.0,,
+254,P2Rank-Vina,8D5D_5DK,,0.0,,
+255,P2Rank-Vina,7JMV_4NC,0.6111111111111112,0.7555555555555555,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+256,P2Rank-Vina,7A9E_R4W,0.9090909090909092,0.6363636363636364,"{'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+257,P2Rank-Vina,7TBU_S3P,0.3846153846153846,0.8461538461538461,"{'UNL:ARG:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+258,P2Rank-Vina,7TB0_UD1,,0.0,,
+259,P2Rank-Vina,7MFP_Z7P,,0.0,,
+260,P2Rank-Vina,6M2B_EZO,0.20000000000000007,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+261,P2Rank-Vina,7NPL_UKZ,0.6551724137931034,0.7379310344827587,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+262,P2Rank-Vina,7KZ9_XN7,,0.0,,
+263,P2Rank-Vina,7QE4_NGA,,0.0,,
+264,P2Rank-Vina,8AP0_PRP,,0.0,,
+265,P2Rank-Vina,7V3S_5I9,0.625,0.75,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+266,P2Rank-Vina,7C0U_FGO,,0.0,,
+267,P2Rank-Vina,7UXS_OJC,,0.0,,
+268,P2Rank-Vina,7X9K_8OG,,0.0,,
+269,P2Rank-Vina,8BOM_QU6,0.39285714285714285,0.8428571428571429,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+270,P2Rank-Vina,8BTI_RFO,,0.0,,
+271,P2Rank-Vina,7RWS_4UR,0.23999999999999994,0.904,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+272,P2Rank-Vina,6YQV_8K2,,0.0,,
+273,P2Rank-Vina,7PK0_BYC,,0.0,,
+274,P2Rank-Vina,5SIS_JSM,0.26086956521739124,0.8956521739130435,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+275,P2Rank-Vina,7NSW_HC4,0.6111111111111112,0.7555555555555555,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+276,P2Rank-Vina,7F8T_FAD,,0.0,,
+277,P2Rank-Vina,5SD5_HWI,,0.0,,
+278,P2Rank-Vina,7CUO_PHB,0.14285714285714285,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+279,P2Rank-Vina,7R3D_APR,0.30434782608695643,0.8782608695652174,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+280,P2Rank-Vina,7WJB_BGC,,0.0,,
+281,P2Rank-Vina,7A1P_QW2,0.19999999999999996,0.92,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+282,P2Rank-Vina,6ZPB_3D1,0.25,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+283,P2Rank-Vina,7UTW_NAI,,0.0,,
+284,P2Rank-Vina,7WUY_76N,,0.0,,
+285,P2Rank-Vina,8A2D_KXY,0.30769230769230765,0.8769230769230769,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+286,P2Rank-Vina,7NR8_UOE,,0.0,,
+287,P2Rank-Vina,7KC5_BJZ,0.6153846153846154,0.7538461538461538,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+288,P2Rank-Vina,7QPP_VDX,0.38095238095238093,0.8476190476190476,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+289,P2Rank-Vina,7VKZ_NOJ,0.411764705882353,0.8352941176470587,"{'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+290,P2Rank-Vina,7F51_BA7,0.1290322580645162,0.9483870967741935,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}"
+291,P2Rank-Vina,7PL1_SFG,,0.0,,
+292,P2Rank-Vina,7VB8_STL,,0.0,,
+293,P2Rank-Vina,8FAV_4Y5,,0.0,,
+294,P2Rank-Vina,7CD9_FVR,0.5238095238095238,0.7904761904761904,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}"
+295,P2Rank-Vina,7N7H_CTP,,0.0,,
+296,P2Rank-Vina,7ODY_DGI,,0.0,,
+297,P2Rank-Vina,8CSD_C5P,,0.0,,
+298,P2Rank-Vina,7OFK_VCH,,0.0,,
+299,P2Rank-Vina,7SDD_4IP,0.5384615384615384,0.7846153846153846,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+300,P2Rank-Vina,7OPG_06N,,0.0,,
+301,P2Rank-Vina,7ZTL_BCN,,0.0,,
+302,P2Rank-Vina,7SIU_9ID,0.3043478260869565,0.8782608695652174,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+303,P2Rank-Vina,7LCU_XTA,,0.0,,
+304,P2Rank-Vina,7NGW_UAW,0.5454545454545453,0.7818181818181819,"{'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+305,P2Rank-Vina,7VYJ_CA0,,0.0,,
+306,P2Rank-Vina,7QHG_T3B,,0.0,,
+307,P2Rank-Vina,8HO0_3ZI,,0.0,,
+308,DiffDock-L,8AAU_LH0,0.42105263157894735,0.8315789473684211,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+309,DiffDock-L,7JHQ_VAJ,0.3076923076923077,0.8769230769230769,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+310,DiffDock-L,6ZCY_QF8,0.09523809523809529,0.9619047619047619,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+311,DiffDock-L,7UAW_MF6,0.4230769230769231,0.8307692307692307,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+312,DiffDock-L,6YMS_OZH,0.08000000000000002,0.968,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+313,DiffDock-L,7UJ5_DGL,0.40000000000000013,0.84,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+314,DiffDock-L,8EX2_Q2Q,0.15384615384615385,0.9384615384615385,"{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+315,DiffDock-L,7R9N_F97,0.4000000000000001,0.84,"{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+316,DiffDock-L,7UYB_OK0,0.1333333333333333,0.9466666666666667,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+317,DiffDock-L,7U0U_FK5,0.1999999999999999,0.92,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+318,DiffDock-L,7ZU2_DHT,0.4705882352941176,0.8117647058823529,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+319,DiffDock-L,6XHT_V2V,0.23809523809523814,0.9047619047619048,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+320,DiffDock-L,7OSO_0V1,,0.0,,
+321,DiffDock-L,8D19_GSH,0.0625,0.975,"{'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+322,DiffDock-L,7MGT_ZD4,0.31034482758620696,0.8758620689655172,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+323,DiffDock-L,8C3N_ADP,0.4375,0.825,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+324,DiffDock-L,6YYO_Q1K,0.08333333333333326,0.9666666666666667,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+325,DiffDock-L,8A1H_DLZ,0.18181818181818185,0.9272727272727272,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+326,DiffDock-L,7XQZ_FPF,0.18181818181818185,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+327,DiffDock-L,7RH3_59O,0.41666666666666663,0.8333333333333334,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+328,DiffDock-L,7OMX_CNA,0.3793103448275863,0.8482758620689654,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+329,DiffDock-L,7LMO_NYO,0.36363636363636365,0.8545454545454545,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+330,DiffDock-L,7VBU_6I4,0.5714285714285714,0.7714285714285715,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+331,DiffDock-L,7TXK_LW8,0.4666666666666667,0.8133333333333334,"{'UNL:ASN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+332,DiffDock-L,7T1D_E7K,0.5217391304347826,0.7913043478260869,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 7, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+333,DiffDock-L,7R59_I5F,0.09090909090909091,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+334,DiffDock-L,7ZCC_OGA,0.27272727272727276,0.8909090909090909,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+335,DiffDock-L,7V43_C4O,,0.0,,
+336,DiffDock-L,7BNH_BEZ,0.07692307692307698,0.9692307692307692,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+337,DiffDock-L,6WTN_RXT,0.16666666666666669,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+338,DiffDock-L,7QFM_AY3,0.22222222222222224,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+339,DiffDock-L,7MSR_DCA,0.36363636363636365,0.8545454545454545,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+340,DiffDock-L,5SAK_ZRY,0.6666666666666667,0.7333333333333333,"{'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+341,DiffDock-L,7QTA_URI,0.4615384615384615,0.8153846153846154,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+342,DiffDock-L,7RSV_7IQ,0.14285714285714293,0.9428571428571428,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1}","{'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+343,DiffDock-L,8DSC_NCA,,0.0,,
+344,DiffDock-L,7AKL_RK5,0.14285714285714296,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+345,DiffDock-L,7XBV_APC,0.10000000000000009,0.96,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+346,DiffDock-L,7CNS_PMV,0.9473684210526315,0.6210526315789474,"{'UNL:ASN:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+347,DiffDock-L,7ZDY_6MJ,0.39999999999999997,0.8400000000000001,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+348,DiffDock-L,6Z4N_Q7B,0.3529411764705882,0.8588235294117648,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+349,DiffDock-L,7NFB_GEN,,0.0,,
+350,DiffDock-L,7R7R_AWJ,0.2222222222222223,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+351,DiffDock-L,7V14_ORU,0.23529411764705882,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+352,DiffDock-L,6YR2_T1C,0.24999999999999997,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+353,DiffDock-L,7JG0_GAR,0.375,0.85,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:V:VdWContact': 1}"
+354,DiffDock-L,7EBG_J0L,0.5833333333333333,0.7666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+355,DiffDock-L,8AY3_OE3,0.23529411764705876,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+356,DiffDock-L,7M6K_YRJ,0.4782608695652174,0.808695652173913,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+357,DiffDock-L,6YT6_PKE,0.28571428571428575,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+358,DiffDock-L,7Q27_8KC,0.2631578947368421,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 3, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+359,DiffDock-L,8DHG_T78,0.22727272727272746,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+360,DiffDock-L,8EXL_799,,0.0,,
+361,DiffDock-L,7FB7_8NF,0.3333333333333333,0.8666666666666667,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+362,DiffDock-L,7THI_PGA,0.8333333333333331,0.6666666666666667,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+363,DiffDock-L,6ZAE_ACV,0.19047619047619052,0.9238095238095237,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+364,DiffDock-L,7MGY_ZD1,0.20000000000000004,0.9199999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+365,DiffDock-L,7XPO_UPG,0.052631578947368474,0.9789473684210526,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+366,DiffDock-L,7SUC_COM,,0.0,,
+367,DiffDock-L,7BJJ_TVW,0.125,0.95,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+368,DiffDock-L,7K0V_VQP,0.18518518518518529,0.9259259259259259,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+369,DiffDock-L,7TE8_P0T,0.4800000000000001,0.8079999999999999,"{'UNL:ALA:Hydrophobic': 5, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+370,DiffDock-L,7QF4_RBF,0.20000000000000007,0.9199999999999999,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+371,DiffDock-L,7UJ4_OQ4,0.3999999999999999,0.8400000000000001,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+372,DiffDock-L,7A9H_TPP,0.20689655172413796,0.9172413793103448,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+373,DiffDock-L,7LEV_0JO,0.43999999999999995,0.8240000000000001,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2}"
+374,DiffDock-L,7N6F_0I1,,0.0,,
+375,DiffDock-L,8EAB_VN2,0.631578947368421,0.7473684210526316,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+376,DiffDock-L,6ZC3_JOR,0.2941176470588235,0.8823529411764706,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+377,DiffDock-L,7Q25_8J9,,0.0,,
+378,DiffDock-L,7C3U_AZG,0.4285714285714286,0.8285714285714285,"{'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2}"
+379,DiffDock-L,7ROR_69X,0.4,0.84,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+380,DiffDock-L,7MMH_ZJY,0.16666666666666677,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+381,DiffDock-L,7TH4_FFO,0.24999999999999994,0.9,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+382,DiffDock-L,8D39_QDB,,0.0,,
+383,DiffDock-L,7YZU_DO7,0.2631578947368422,0.8947368421052632,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+384,DiffDock-L,5SB2_1K2,0.20000000000000007,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+385,DiffDock-L,6M73_FNR,0.11111111111111116,0.9555555555555555,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+386,DiffDock-L,8B8H_OJQ,0.039999999999999925,0.984,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+387,DiffDock-L,7TOM_5AD,0.2400000000000001,0.9039999999999999,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+388,DiffDock-L,7VWF_K55,0.41666666666666663,0.8333333333333334,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+389,DiffDock-L,7XI7_4RI,0.08333333333333337,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+390,DiffDock-L,7AN5_RDH,0.3913043478260869,0.8434782608695652,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+391,DiffDock-L,7B2C_TP7,,0.0,,
+392,DiffDock-L,7B94_ANP,0.15999999999999998,0.936,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+393,DiffDock-L,7NF0_BYN,0.32352941176470584,0.8705882352941177,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}"
+394,DiffDock-L,7WKL_CAQ,0.125,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+395,DiffDock-L,7WPW_F15,0.21052631578947373,0.9157894736842105,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+396,DiffDock-L,8SLG_G5A,0.3157894736842106,0.8736842105263157,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+397,DiffDock-L,7RNI_60I,0.2941176470588235,0.8823529411764706,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 3}"
+398,DiffDock-L,7SZA_DUI,0.16666666666666674,0.9333333333333333,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+399,DiffDock-L,7PIH_7QW,0.18181818181818177,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+400,DiffDock-L,7T3E_SLB,0.875,0.65,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+401,DiffDock-L,7FRX_O88,,0.0,,
+402,DiffDock-L,8CNH_V6U,0.28571428571428586,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 5, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+403,DiffDock-L,7C8Q_DSG,0.3,0.88,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:DSG:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+404,DiffDock-L,7ZF0_DHR,0.2222222222222222,0.9111111111111111,"{'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3}"
+405,DiffDock-L,8G0V_YHT,0.24999999999999992,0.9,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+406,DiffDock-L,7P5T_5YG,,0.0,,
+407,DiffDock-L,7NU0_DCL,0.09090909090909091,0.9636363636363636,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+408,DiffDock-L,6Z0R_Q4H,0.7692307692307692,0.6923076923076923,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}"
+409,DiffDock-L,7XRL_FWK,,0.0,,
+410,DiffDock-L,7LOU_IFM,0.11764705882352944,0.9529411764705882,"{'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:UDP:VdWContact': 1}"
+411,DiffDock-L,7ROU_66I,0.2000000000000001,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+412,DiffDock-L,6XCT_478,,0.0,,
+413,DiffDock-L,7LT0_ONJ,0.09090909090909088,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+414,DiffDock-L,7OLI_8HG,0.10526315789473684,0.9578947368421052,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+415,DiffDock-L,7Z1Q_NIO,0.3571428571428571,0.8571428571428572,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+416,DiffDock-L,6YQW_82I,0.1,0.96,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+417,DiffDock-L,6T88_MWQ,0.06666666666666665,0.9733333333333334,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+418,DiffDock-L,7PRI_7TI,0.4117647058823529,0.8352941176470589,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1}"
+419,DiffDock-L,7OFF_VCB,0.46666666666666673,0.8133333333333332,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+420,DiffDock-L,7DQL_4CL,0.23076923076923084,0.9076923076923077,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+421,DiffDock-L,7O1T_5X8,0.21428571428571425,0.9142857142857143,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+422,DiffDock-L,7KM8_WPD,0.1739130434782608,0.9304347826086957,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+423,DiffDock-L,7ZXV_45D,0.38461538461538464,0.8461538461538461,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL::Hydrophobic': 1, 'UNL::VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+424,DiffDock-L,7X5N_5M5,0.2941176470588236,0.8823529411764706,"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+425,DiffDock-L,7VQ9_ISY,0.21052631578947362,0.9157894736842106,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+426,DiffDock-L,7PJQ_OWH,0.26666666666666666,0.8933333333333333,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+427,DiffDock-L,8AQL_PLG,0.23529411764705876,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+428,DiffDock-L,7VC5_9SF,0.3125,0.875,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+429,DiffDock-L,7AFX_R9K,0.21428571428571427,0.9142857142857143,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+430,DiffDock-L,7RKW_5TV,,0.0,,
+431,DiffDock-L,7TYP_KUR,0.56,0.776,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+432,DiffDock-L,7L03_F9F,0.09523809523809523,0.9619047619047619,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+433,DiffDock-L,7P1F_KFN,0.46153846153846156,0.8153846153846154,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+434,DiffDock-L,7O0N_CDP,0.3846153846153846,0.8461538461538461,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+435,DiffDock-L,7MYU_ZR7,0.28571428571428575,0.8857142857142857,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+436,DiffDock-L,6YSP_PAL,1.3125,0.475,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+437,DiffDock-L,7XJN_NSD,,0.0,,
+438,DiffDock-L,7R6J_2I7,0.33333333333333337,0.8666666666666667,"{'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+439,DiffDock-L,8HFN_XGC,0.5217391304347827,0.7913043478260869,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+440,DiffDock-L,7BTT_F8R,0.26666666666666666,0.8933333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+441,DiffDock-L,7MY1_IPE,0.16666666666666666,0.9333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+442,DiffDock-L,8FO5_Y4U,0.5555555555555556,0.7777777777777778,"{'UNL:GLU:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 4}","{'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}"
+443,DiffDock-L,8AUH_L9I,0.6428571428571429,0.7428571428571429,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:MET:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+444,DiffDock-L,7ECR_SIN,0.5714285714285714,0.7714285714285715,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+445,DiffDock-L,6TW5_9M2,0.3529411764705882,0.8588235294117648,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+446,DiffDock-L,7ELT_TYM,0.6785714285714286,0.7285714285714285,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}"
+447,DiffDock-L,7D5C_GV6,0.15384615384615377,0.9384615384615385,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+448,DiffDock-L,7W06_ITN,0.29411764705882354,0.8823529411764706,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+449,DiffDock-L,6YJA_2BA,0.4,0.84,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+450,DiffDock-L,7P1M_4IU,0.4166666666666666,0.8333333333333334,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+451,DiffDock-L,7PGX_FMN,0.2380952380952382,0.9047619047619048,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+452,DiffDock-L,7UAS_MBU,0.3888888888888888,0.8444444444444446,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+453,DiffDock-L,8GFD_ZHR,0.3333333333333333,0.8666666666666667,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+454,DiffDock-L,7CTM_BDP,0.4999999999999999,0.8,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CSD:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1}"
+455,DiffDock-L,7UQ3_O2U,0.0,1.0,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+456,DiffDock-L,7DKT_GLF,0.23076923076923067,0.9076923076923077,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+457,DiffDock-L,7CNQ_G8X,,0.0,,
+458,DiffDock-L,6Z1C_7EY,0.125,0.95,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}"
+459,DiffDock-L,7M3H_YPV,0.5333333333333333,0.7866666666666666,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1}"
+460,DiffDock-L,7D6O_MTE,,0.0,,
+461,DiffDock-L,7N4W_P4V,0.05882352941176472,0.9764705882352941,"{'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+462,DiffDock-L,6Z2C_Q5E,0.5,0.8,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+463,DiffDock-L,7CIJ_G0C,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2}"
+464,DiffDock-L,7USH_82V,0.15384615384615385,0.9384615384615385,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+465,DiffDock-L,7XG5_PLP,0.1428571428571429,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+466,DiffDock-L,7PT3_3KK,0.41666666666666674,0.8333333333333333,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+467,DiffDock-L,7KB1_WBJ,0.04347826086956519,0.9826086956521739,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+468,DiffDock-L,7WUX_6OI,0.2222222222222222,0.9111111111111111,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}"
+469,DiffDock-L,7OZ9_NGK,0.4444444444444445,0.8222222222222222,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+470,DiffDock-L,7N03_ZRP,0.1904761904761904,0.9238095238095239,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+471,DiffDock-L,7BMI_U4B,0.3125,0.875,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+472,DiffDock-L,7RZL_NPO,0.09999999999999998,0.96,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+473,DiffDock-L,7QHL_D5P,0.1578947368421052,0.9368421052631579,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+474,DiffDock-L,7N7B_T3F,0.1428571428571429,0.9428571428571428,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+475,DiffDock-L,7Q5I_I0F,0.11764705882352944,0.9529411764705882,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+476,DiffDock-L,7BKA_4JC,,0.0,,
+477,DiffDock-L,7NXO_UU8,0.35,0.86,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+478,DiffDock-L,6XG5_TOP,0.07142857142857142,0.9714285714285714,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+479,DiffDock-L,6XBO_5MC,0.7000000000000001,0.72,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+480,DiffDock-L,8DKO_TFB,0.21428571428571425,0.9142857142857143,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+481,DiffDock-L,7LJN_GTP,0.1578947368421052,0.9368421052631579,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+482,DiffDock-L,7MOI_HPS,0.07692307692307698,0.9692307692307692,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}"
+483,DiffDock-L,8G6P_API,0.4736842105263157,0.8105263157894738,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+484,DiffDock-L,7ULC_56B,0.4761904761904762,0.8095238095238095,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+485,DiffDock-L,7RC3_SAH,0.12499999999999997,0.95,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+486,DiffDock-L,7SFO_98L,0.42105263157894735,0.8315789473684211,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+487,DiffDock-L,8DP2_UMA,0.21739130434782616,0.9130434782608695,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+488,DiffDock-L,7ZZW_KKW,0.1875,0.925,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+489,DiffDock-L,7XFA_D9J,0.33333333333333326,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+490,DiffDock-L,7NP6_UK8,0.42857142857142855,0.8285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+491,DiffDock-L,7F5D_EUO,0.11764705882352944,0.9529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+492,DiffDock-L,6TW7_NZB,0.09090909090909091,0.9636363636363636,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+493,DiffDock-L,7FHA_ADX,0.36842105263157887,0.8526315789473684,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+494,DiffDock-L,7ES1_UDP,0.22222222222222224,0.9111111111111111,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+495,DiffDock-L,7OEO_V9Z,0.11764705882352944,0.9529411764705882,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+496,DiffDock-L,7DUA_HJ0,0.125,0.95,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+497,DiffDock-L,7BCP_GCO,0.21428571428571425,0.9142857142857143,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+498,DiffDock-L,7P2I_MFU,0.09090909090909094,0.9636363636363636,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}"
+499,DiffDock-L,7WDT_NGS,0.5714285714285715,0.7714285714285714,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+500,DiffDock-L,8AEM_LVF,0.2500000000000001,0.8999999999999999,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+501,DiffDock-L,7WY1_D0L,,0.0,,
+502,DiffDock-L,7KRU_ATP,0.2777777777777778,0.8888888888888888,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}"
+503,DiffDock-L,7P4C_5OV,0.18181818181818174,0.9272727272727272,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 2}"
+504,DiffDock-L,7MWN_WI5,0.17391304347826086,0.9304347826086956,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+505,DiffDock-L,7ZHP_IQY,0.21739130434782603,0.9130434782608696,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+506,DiffDock-L,7W05_GMP,0.5714285714285714,0.7714285714285715,"{'UNL:ASN:HBDonor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+507,DiffDock-L,7UJF_R3V,0.375,0.85,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 5, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+508,DiffDock-L,7LOE_Y84,0.3571428571428571,0.8571428571428572,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+509,DiffDock-L,8AIE_M7L,0.263157894736842,0.8947368421052632,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 4, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+510,DiffDock-L,7JY3_VUD,,0.0,,
+511,DiffDock-L,6XM9_V55,0.0714285714285714,0.9714285714285714,"{'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+512,DiffDock-L,7POM_7VZ,0.42857142857142844,0.8285714285714286,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+513,DiffDock-L,7M31_TDR,,0.0,,
+514,DiffDock-L,8EYE_X4I,0.047619047619047616,0.9809523809523809,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+515,DiffDock-L,6YRV_PJ8,0.2727272727272727,0.8909090909090909,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+516,DiffDock-L,7LZD_YHY,0.22727272727272735,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+517,DiffDock-L,7EPV_FDA,0.15999999999999992,0.936,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+518,DiffDock-L,7UY4_SMI,0.26666666666666666,0.8933333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+519,DiffDock-L,7N4N_0BK,0.3157894736842106,0.8736842105263157,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+520,DiffDock-L,7UMW_NAD,0.11538461538461545,0.9538461538461538,"{'UNL:ALA:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+521,DiffDock-L,7U3J_L6U,0.31034482758620685,0.8758620689655172,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+522,DiffDock-L,6Z14_Q4Z,0.1428571428571429,0.9428571428571428,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+523,DiffDock-L,6ZK5_IMH,0.2631578947368421,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+524,DiffDock-L,7QGP_DJ8,0.2272727272727274,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+525,DiffDock-L,7L5F_XNG,0.5,0.8,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+526,DiffDock-L,7FT9_4MB,0.6153846153846154,0.7538461538461538,"{'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+527,DiffDock-L,7OP9_06K,,0.0,,
+528,DiffDock-L,7JXX_VP7,0.21739130434782603,0.9130434782608696,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+529,DiffDock-L,7CL8_TES,,0.0,,
+530,DiffDock-L,7TM6_GPJ,0.5,0.8,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+531,DiffDock-L,7WQQ_5Z6,0.38888888888888884,0.8444444444444444,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+532,DiffDock-L,7WL4_JFU,0.1578947368421053,0.9368421052631579,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+533,DiffDock-L,7SCW_GSP,0.217391304347826,0.9130434782608696,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+534,DiffDock-L,7L7C_XQ1,0.5,0.8,"{'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2}","{'UNL:GLN:Hydrophobic': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+535,DiffDock-L,7PUV_84Z,0.0625,0.975,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+536,DiffDock-L,7KQU_YOF,,0.0,,
+537,DiffDock-L,7Z2O_IAJ,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+538,DiffDock-L,7PRM_81I,0.21739130434782597,0.9130434782608696,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+539,DiffDock-L,8FLV_ZB9,0.1538461538461539,0.9384615384615385,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+540,DiffDock-L,7NLV_UJE,0.5789473684210528,0.7684210526315789,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+541,DiffDock-L,7T0D_FPP,0.06666666666666665,0.9733333333333334,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 5}"
+542,DiffDock-L,7MWU_ZPM,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+543,DiffDock-L,7L00_XCJ,,0.0,,
+544,DiffDock-L,8C5M_MTA,0.39999999999999997,0.8400000000000001,"{'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+545,DiffDock-L,7Z7F_IF3,0.14285714285714282,0.9428571428571428,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+546,DiffDock-L,7TSF_H4B,,0.0,,
+547,DiffDock-L,7TUO_KL9,0.3636363636363636,0.8545454545454545,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+548,DiffDock-L,7ED2_A3P,0.5238095238095238,0.7904761904761904,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+549,DiffDock-L,7ZL5_IWE,0.5384615384615385,0.7846153846153846,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+550,DiffDock-L,8F8E_XJI,0.20000000000000007,0.9199999999999999,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+551,DiffDock-L,7OZC_G6S,0.23529411764705888,0.9058823529411765,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+552,DiffDock-L,7Q2B_M6H,0.28571428571428564,0.8857142857142858,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+553,DiffDock-L,6VTA_AKN,0.27272727272727276,0.8909090909090909,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+554,DiffDock-L,7V3N_AKG,0.30000000000000004,0.88,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+555,DiffDock-L,8F4J_PHO,,0.0,,
+556,DiffDock-L,7ZOC_T8E,0.30769230769230765,0.8769230769230769,"{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+557,DiffDock-L,7WCF_ACP,0.08000000000000004,0.968,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+558,DiffDock-L,7NUT_GLP,0.1875,0.925,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}"
+559,DiffDock-L,7E4L_MDN,0.30769230769230776,0.8769230769230769,"{'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+560,DiffDock-L,7TS6_KMI,,0.0,,
+561,DiffDock-L,7NF3_4LU,,0.0,,
+562,DiffDock-L,8D5D_5DK,0.2173913043478261,0.9130434782608695,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+563,DiffDock-L,7JMV_4NC,0.47058823529411764,0.8117647058823529,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+564,DiffDock-L,7A9E_R4W,0.1428571428571429,0.9428571428571428,"{'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+565,DiffDock-L,7TBU_S3P,0.30769230769230765,0.8769230769230769,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+566,DiffDock-L,7TB0_UD1,0.39130434782608703,0.8434782608695652,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+567,DiffDock-L,7MFP_Z7P,0.44117647058823534,0.8235294117647058,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 5, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+568,DiffDock-L,6M2B_EZO,0.045454545454545414,0.9818181818181818,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+569,DiffDock-L,7NPL_UKZ,0.46666666666666673,0.8133333333333332,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+570,DiffDock-L,7KZ9_XN7,0.08333333333333337,0.9666666666666667,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+571,DiffDock-L,7QE4_NGA,0.5555555555555556,0.7777777777777778,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+572,DiffDock-L,8AP0_PRP,0.7857142857142856,0.6857142857142857,"{'UNL:ARG:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+573,DiffDock-L,7V3S_5I9,0.3199999999999999,0.8720000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+574,DiffDock-L,7C0U_FGO,0.21739130434782622,0.9130434782608695,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}"
+575,DiffDock-L,7UXS_OJC,0.38095238095238093,0.8476190476190476,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+576,DiffDock-L,7X9K_8OG,0.4347826086956521,0.8260869565217391,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+577,DiffDock-L,8BOM_QU6,0.20000000000000004,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+578,DiffDock-L,8BTI_RFO,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+579,DiffDock-L,7RWS_4UR,0.25000000000000006,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+580,DiffDock-L,6YQV_8K2,0.25,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+581,DiffDock-L,7PK0_BYC,0.20000000000000007,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 4, 'UNL:GLN:VdWContact': 5, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+582,DiffDock-L,5SIS_JSM,0.21739130434782614,0.9130434782608695,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+583,DiffDock-L,7NSW_HC4,0.7777777777777778,0.6888888888888889,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+584,DiffDock-L,7F8T_FAD,0.12903225806451613,0.9483870967741935,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+585,DiffDock-L,5SD5_HWI,0.25,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+586,DiffDock-L,7CUO_PHB,0.111111111111111,0.9555555555555556,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+587,DiffDock-L,7R3D_APR,0.050000000000000044,0.98,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+588,DiffDock-L,7WJB_BGC,0.1538461538461539,0.9384615384615385,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+589,DiffDock-L,7A1P_QW2,0.050000000000000044,0.98,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+590,DiffDock-L,6ZPB_3D1,0.16666666666666666,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+591,DiffDock-L,7UTW_NAI,0.30434782608695665,0.8782608695652173,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+592,DiffDock-L,7WUY_76N,0.42105263157894735,0.8315789473684211,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+593,DiffDock-L,8A2D_KXY,0.1538461538461538,0.9384615384615385,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+594,DiffDock-L,7NR8_UOE,0.15999999999999998,0.936,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+595,DiffDock-L,7KC5_BJZ,0.5333333333333333,0.7866666666666666,"{'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+596,DiffDock-L,7QPP_VDX,0.3333333333333334,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+597,DiffDock-L,7VKZ_NOJ,0.3076923076923077,0.8769230769230769,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+598,DiffDock-L,7F51_BA7,0.24137931034482762,0.903448275862069,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}"
+599,DiffDock-L,7PL1_SFG,0.08333333333333334,0.9666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+600,DiffDock-L,7VB8_STL,0.2142857142857143,0.9142857142857143,"{'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+601,DiffDock-L,8FAV_4Y5,0.31034482758620685,0.8758620689655172,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+602,DiffDock-L,7CD9_FVR,0.12,0.952,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}"
+603,DiffDock-L,7N7H_CTP,0.5384615384615384,0.7846153846153846,"{'UNL:ASN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+604,DiffDock-L,7ODY_DGI,0.1904761904761904,0.9238095238095239,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2}"
+605,DiffDock-L,8CSD_C5P,0.46666666666666673,0.8133333333333332,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+606,DiffDock-L,7OFK_VCH,0.22727272727272724,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+607,DiffDock-L,7SDD_4IP,0.6666666666666666,0.7333333333333334,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+608,DiffDock-L,7OPG_06N,0.42857142857142855,0.8285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+609,DiffDock-L,7ZTL_BCN,0.0,1.0,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+610,DiffDock-L,7SIU_9ID,0.423076923076923,0.8307692307692308,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+611,DiffDock-L,7LCU_XTA,0.3043478260869565,0.8782608695652174,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+612,DiffDock-L,7NGW_UAW,0.18181818181818166,0.9272727272727274,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+613,DiffDock-L,7VYJ_CA0,0.26315789473684204,0.8947368421052632,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+614,DiffDock-L,7QHG_T3B,0.034482758620689724,0.9862068965517241,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+615,DiffDock-L,8HO0_3ZI,,0.0,,
+616,DynamicBind,8AAU_LH0,0.5263157894736843,0.7894736842105263,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+617,DynamicBind,7JHQ_VAJ,0.25,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+618,DynamicBind,6ZCY_QF8,0.1818181818181819,0.9272727272727272,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+619,DynamicBind,7UAW_MF6,0.3846153846153846,0.8461538461538461,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+620,DynamicBind,6YMS_OZH,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+621,DynamicBind,7UJ5_DGL,0.7222222222222221,0.7111111111111111,"{'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+622,DynamicBind,8EX2_Q2Q,0.38461538461538464,0.8461538461538461,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+623,DynamicBind,7R9N_F97,,0.0,,
+624,DynamicBind,7UYB_OK0,0.4666666666666667,0.8133333333333334,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+625,DynamicBind,7U0U_FK5,,0.0,,
+626,DynamicBind,7ZU2_DHT,,0.0,,
+627,DynamicBind,6XHT_V2V,,0.0,,
+628,DynamicBind,7OSO_0V1,0.45454545454545453,0.8181818181818181,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+629,DynamicBind,8D19_GSH,,0.0,,
+630,DynamicBind,7MGT_ZD4,0.37037037037037035,0.8518518518518519,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+631,DynamicBind,8C3N_ADP,0.11538461538461536,0.9538461538461539,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 4, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+632,DynamicBind,6YYO_Q1K,0.08333333333333326,0.9666666666666667,"{'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+633,DynamicBind,8A1H_DLZ,,0.0,,
+634,DynamicBind,7XQZ_FPF,0.06666666666666665,0.9733333333333334,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+635,DynamicBind,7RH3_59O,0.07692307692307693,0.9692307692307692,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+636,DynamicBind,7OMX_CNA,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+637,DynamicBind,7LMO_NYO,0.5909090909090908,0.7636363636363637,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+638,DynamicBind,7VBU_6I4,,0.0,,
+639,DynamicBind,7TXK_LW8,0.6428571428571429,0.7428571428571429,"{'UNL:ASN:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+640,DynamicBind,7T1D_E7K,,0.0,,
+641,DynamicBind,7R59_I5F,0.30000000000000004,0.88,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+642,DynamicBind,7ZCC_OGA,0.4,0.84,"{'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+643,DynamicBind,7V43_C4O,0.6666666666666667,0.7333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+644,DynamicBind,7BNH_BEZ,0.4444444444444444,0.8222222222222222,"{'UNL:ILE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+645,DynamicBind,6WTN_RXT,0.24999999999999994,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+646,DynamicBind,7QFM_AY3,0.2857142857142856,0.8857142857142858,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+647,DynamicBind,7MSR_DCA,0.16666666666666674,0.9333333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 6, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+648,DynamicBind,5SAK_ZRY,0.6000000000000001,0.76,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+649,DynamicBind,7QTA_URI,0.49999999999999994,0.8,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+650,DynamicBind,7RSV_7IQ,0.18181818181818185,0.9272727272727272,"{'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+651,DynamicBind,8DSC_NCA,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+652,DynamicBind,7AKL_RK5,,0.0,,
+653,DynamicBind,7XBV_APC,,0.0,,
+654,DynamicBind,7CNS_PMV,1.1052631578947372,0.5578947368421051,"{'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+655,DynamicBind,7ZDY_6MJ,0.4285714285714286,0.8285714285714285,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+656,DynamicBind,6Z4N_Q7B,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+657,DynamicBind,7NFB_GEN,,0.0,,
+658,DynamicBind,7R7R_AWJ,0.20000000000000007,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+659,DynamicBind,7V14_ORU,0.29411764705882354,0.8823529411764706,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+660,DynamicBind,6YR2_T1C,,0.0,,
+661,DynamicBind,7JG0_GAR,0.25,0.9,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:V:VdWContact': 1}"
+662,DynamicBind,7EBG_J0L,0.6153846153846154,0.7538461538461538,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+663,DynamicBind,8AY3_OE3,0.3684210526315789,0.8526315789473684,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+664,DynamicBind,7M6K_YRJ,0.23529411764705882,0.9058823529411765,"{'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+665,DynamicBind,6YT6_PKE,0.29999999999999993,0.88,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+666,DynamicBind,7Q27_8KC,0.3500000000000001,0.86,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+667,DynamicBind,8DHG_T78,0.36666666666666675,0.8533333333333333,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+668,DynamicBind,8EXL_799,0.34782608695652173,0.8608695652173913,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+669,DynamicBind,7FB7_8NF,0.29411764705882354,0.8823529411764706,"{'UNL:ASP:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+670,DynamicBind,7THI_PGA,0.8333333333333333,0.6666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+671,DynamicBind,6ZAE_ACV,0.11111111111111113,0.9555555555555555,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+672,DynamicBind,7MGY_ZD1,0.0,1.0,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+673,DynamicBind,7XPO_UPG,0.36363636363636365,0.8545454545454545,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+674,DynamicBind,7SUC_COM,,0.0,,
+675,DynamicBind,7BJJ_TVW,0.125,0.95,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+676,DynamicBind,7K0V_VQP,,0.0,,
+677,DynamicBind,7TE8_P0T,0.18518518518518523,0.9259259259259259,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+678,DynamicBind,7QF4_RBF,0.55,0.78,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+679,DynamicBind,7UJ4_OQ4,0.2499999999999999,0.9,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+680,DynamicBind,7A9H_TPP,0.17241379310344834,0.9310344827586207,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+681,DynamicBind,7LEV_0JO,0.45833333333333326,0.8166666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2}"
+682,DynamicBind,7N6F_0I1,,0.0,,
+683,DynamicBind,8EAB_VN2,0.875,0.65,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 3, 'UNL:SER:VdWContact': 5, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+684,DynamicBind,6ZC3_JOR,0.47058823529411764,0.8117647058823529,"{'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+685,DynamicBind,7Q25_8J9,,0.0,,
+686,DynamicBind,7C3U_AZG,0.3571428571428571,0.8571428571428572,"{'UNL:ALA:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2}"
+687,DynamicBind,7ROR_69X,0.7096774193548386,0.7161290322580646,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+688,DynamicBind,7MMH_ZJY,,0.0,,
+689,DynamicBind,7TH4_FFO,,0.0,,
+690,DynamicBind,8D39_QDB,0.2857142857142856,0.8857142857142858,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+691,DynamicBind,7YZU_DO7,0.49999999999999994,0.8,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+692,DynamicBind,5SB2_1K2,0.20000000000000004,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+693,DynamicBind,6M73_FNR,0.2777777777777778,0.8888888888888888,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+694,DynamicBind,8B8H_OJQ,0.3793103448275863,0.8482758620689654,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+695,DynamicBind,7TOM_5AD,0.06896551724137928,0.9724137931034483,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+696,DynamicBind,7VWF_K55,0.47999999999999987,0.808,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+697,DynamicBind,7XI7_4RI,0.21428571428571425,0.9142857142857143,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+698,DynamicBind,7AN5_RDH,0.6666666666666667,0.7333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+699,DynamicBind,7B2C_TP7,,0.0,,
+700,DynamicBind,7B94_ANP,0.13043478260869565,0.9478260869565217,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+701,DynamicBind,7NF0_BYN,0.39999999999999997,0.8400000000000001,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}"
+702,DynamicBind,7WKL_CAQ,0.17647058823529416,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+703,DynamicBind,7WPW_F15,0.10526315789473695,0.9578947368421052,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+704,DynamicBind,8SLG_G5A,0.3157894736842106,0.8736842105263157,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+705,DynamicBind,7RNI_60I,0.33333333333333326,0.8666666666666667,"{'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 3}"
+706,DynamicBind,7SZA_DUI,0.4117647058823529,0.8352941176470589,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+707,DynamicBind,7PIH_7QW,0.12500000000000003,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+708,DynamicBind,7T3E_SLB,,0.0,,
+709,DynamicBind,7FRX_O88,,0.0,,
+710,DynamicBind,8CNH_V6U,0.20000000000000007,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+711,DynamicBind,7C8Q_DSG,0.4736842105263158,0.8105263157894737,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:DSG:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+712,DynamicBind,7ZF0_DHR,0.2727272727272727,0.8909090909090909,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3}"
+713,DynamicBind,8G0V_YHT,,0.0,,
+714,DynamicBind,7P5T_5YG,0.4,0.84,"{'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+715,DynamicBind,7NU0_DCL,0.18181818181818177,0.9272727272727272,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+716,DynamicBind,6Z0R_Q4H,,0.0,,
+717,DynamicBind,7XRL_FWK,0.35,0.86,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+718,DynamicBind,7LOU_IFM,,0.0,,
+719,DynamicBind,7ROU_66I,0.6785714285714285,0.7285714285714286,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+720,DynamicBind,6XCT_478,0.4,0.84,"{'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+721,DynamicBind,7LT0_ONJ,0.30000000000000004,0.88,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+722,DynamicBind,7OLI_8HG,0.10526315789473684,0.9578947368421052,"{'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+723,DynamicBind,7Z1Q_NIO,0.27272727272727276,0.8909090909090909,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+724,DynamicBind,6YQW_82I,0.39999999999999997,0.8400000000000001,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+725,DynamicBind,6T88_MWQ,0.4615384615384615,0.8153846153846154,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+726,DynamicBind,7PRI_7TI,0.125,0.95,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1}"
+727,DynamicBind,7OFF_VCB,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+728,DynamicBind,7DQL_4CL,0.15384615384615385,0.9384615384615385,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+729,DynamicBind,7O1T_5X8,,0.0,,
+730,DynamicBind,7KM8_WPD,0.21739130434782603,0.9130434782608696,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+731,DynamicBind,7ZXV_45D,0.3125,0.875,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL::Hydrophobic': 1, 'UNL::VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+732,DynamicBind,7X5N_5M5,0.20833333333333334,0.9166666666666666,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+733,DynamicBind,7VQ9_ISY,0.3125,0.875,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+734,DynamicBind,7PJQ_OWH,0.21428571428571425,0.9142857142857143,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+735,DynamicBind,8AQL_PLG,0.33333333333333337,0.8666666666666667,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+736,DynamicBind,7VC5_9SF,0.2777777777777778,0.8888888888888888,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+737,DynamicBind,7AFX_R9K,0.2857142857142857,0.8857142857142857,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+738,DynamicBind,7RKW_5TV,0.23529411764705885,0.9058823529411765,"{'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+739,DynamicBind,7TYP_KUR,0.5185185185185186,0.7925925925925925,"{'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+740,DynamicBind,7L03_F9F,0.09999999999999998,0.96,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+741,DynamicBind,7P1F_KFN,0.3999999999999999,0.8400000000000001,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+742,DynamicBind,7O0N_CDP,0.8181818181818181,0.6727272727272727,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+743,DynamicBind,7MYU_ZR7,,0.0,,
+744,DynamicBind,6YSP_PAL,1.25,0.5,"{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+745,DynamicBind,7XJN_NSD,0.9090909090909091,0.6363636363636364,"{'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+746,DynamicBind,7R6J_2I7,0.11764705882352944,0.9529411764705882,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+747,DynamicBind,8HFN_XGC,0.21428571428571436,0.9142857142857143,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+748,DynamicBind,7BTT_F8R,0.2666666666666667,0.8933333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+749,DynamicBind,7MY1_IPE,0.09090909090909083,0.9636363636363636,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+750,DynamicBind,8FO5_Y4U,0.6666666666666667,0.7333333333333333,"{'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}"
+751,DynamicBind,8AUH_L9I,0.3846153846153847,0.8461538461538461,"{'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+752,DynamicBind,7ECR_SIN,0.4285714285714285,0.8285714285714286,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+753,DynamicBind,6TW5_9M2,0.29999999999999993,0.88,"{'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+754,DynamicBind,7ELT_TYM,0.4666666666666667,0.8133333333333334,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}"
+755,DynamicBind,7D5C_GV6,0.17857142857142855,0.9285714285714286,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+756,DynamicBind,7W06_ITN,0.2777777777777778,0.8888888888888888,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+757,DynamicBind,6YJA_2BA,0.368421052631579,0.8526315789473684,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+758,DynamicBind,7P1M_4IU,0.5384615384615385,0.7846153846153846,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+759,DynamicBind,7PGX_FMN,0.47619047619047616,0.8095238095238095,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+760,DynamicBind,7UAS_MBU,0.23529411764705888,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+761,DynamicBind,8GFD_ZHR,0.2857142857142857,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+762,DynamicBind,7CTM_BDP,0.42857142857142866,0.8285714285714285,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CSD:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1}"
+763,DynamicBind,7UQ3_O2U,0.2,0.92,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+764,DynamicBind,7DKT_GLF,0.4000000000000001,0.84,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+765,DynamicBind,7CNQ_G8X,,0.0,,
+766,DynamicBind,6Z1C_7EY,0.05555555555555558,0.9777777777777777,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}"
+767,DynamicBind,7M3H_YPV,0.5384615384615385,0.7846153846153846,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 5, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1}"
+768,DynamicBind,7D6O_MTE,,0.0,,
+769,DynamicBind,7N4W_P4V,0.2631578947368421,0.8947368421052632,"{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+770,DynamicBind,6Z2C_Q5E,,0.0,,
+771,DynamicBind,7CIJ_G0C,0.32,0.872,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2}"
+772,DynamicBind,7USH_82V,0.1538461538461538,0.9384615384615385,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+773,DynamicBind,7XG5_PLP,0.3529411764705883,0.8588235294117647,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+774,DynamicBind,7PT3_3KK,0.3125,0.875,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+775,DynamicBind,7KB1_WBJ,,0.0,,
+776,DynamicBind,7WUX_6OI,,0.0,,
+777,DynamicBind,7OZ9_NGK,0.3636363636363636,0.8545454545454545,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+778,DynamicBind,7N03_ZRP,0.3529411764705883,0.8588235294117647,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+779,DynamicBind,7BMI_U4B,0.5294117647058822,0.7882352941176471,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+780,DynamicBind,7RZL_NPO,0.7142857142857142,0.7142857142857143,{'UNL:ARG:VdWContact': 1},"{'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+781,DynamicBind,7QHL_D5P,0.05555555555555555,0.9777777777777777,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+782,DynamicBind,7N7B_T3F,0.23076923076923084,0.9076923076923077,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+783,DynamicBind,7Q5I_I0F,,0.0,,
+784,DynamicBind,7BKA_4JC,,0.0,,
+785,DynamicBind,7NXO_UU8,0.13636363636363627,0.9454545454545455,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+786,DynamicBind,6XG5_TOP,0.3076923076923076,0.8769230769230769,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+787,DynamicBind,6XBO_5MC,,0.0,,
+788,DynamicBind,8DKO_TFB,0.375,0.85,"{'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+789,DynamicBind,7LJN_GTP,0.23809523809523814,0.9047619047619048,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+790,DynamicBind,7MOI_HPS,0.27272727272727276,0.8909090909090909,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}"
+791,DynamicBind,8G6P_API,0.3157894736842105,0.8736842105263158,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+792,DynamicBind,7ULC_56B,0.29166666666666663,0.8833333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+793,DynamicBind,7RC3_SAH,0.04166666666666663,0.9833333333333334,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+794,DynamicBind,7SFO_98L,0.30000000000000004,0.88,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 5, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+795,DynamicBind,8DP2_UMA,0.28571428571428575,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+796,DynamicBind,7ZZW_KKW,0.36842105263157887,0.8526315789473684,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+797,DynamicBind,7XFA_D9J,0.09090909090909091,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+798,DynamicBind,7NP6_UK8,0.40740740740740744,0.837037037037037,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+799,DynamicBind,7F5D_EUO,0.25,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+800,DynamicBind,6TW7_NZB,0.4666666666666667,0.8133333333333334,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+801,DynamicBind,7FHA_ADX,0.5789473684210528,0.7684210526315789,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+802,DynamicBind,7ES1_UDP,0.6111111111111112,0.7555555555555555,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+803,DynamicBind,7OEO_V9Z,0.33333333333333337,0.8666666666666667,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+804,DynamicBind,7DUA_HJ0,0.0,1.0,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+805,DynamicBind,7BCP_GCO,0.125,0.95,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+806,DynamicBind,7P2I_MFU,0.6363636363636364,0.7454545454545455,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}"
+807,DynamicBind,7WDT_NGS,0.7857142857142858,0.6857142857142857,"{'UNL:GLU:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+808,DynamicBind,8AEM_LVF,0.33333333333333337,0.8666666666666667,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+809,DynamicBind,7WY1_D0L,0.6363636363636362,0.7454545454545455,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+810,DynamicBind,7KRU_ATP,,0.0,,
+811,DynamicBind,7P4C_5OV,0.19999999999999996,0.92,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 2}"
+812,DynamicBind,7MWN_WI5,0.13043478260869562,0.9478260869565217,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+813,DynamicBind,7ZHP_IQY,0.40909090909090906,0.8363636363636364,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+814,DynamicBind,7W05_GMP,0.7058823529411764,0.7176470588235294,"{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+815,DynamicBind,7UJF_R3V,,0.0,,
+816,DynamicBind,7LOE_Y84,0.3571428571428571,0.8571428571428572,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+817,DynamicBind,8AIE_M7L,0.4000000000000001,0.84,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+818,DynamicBind,7JY3_VUD,0.2666666666666668,0.8933333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+819,DynamicBind,6XM9_V55,0.0625,0.975,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+820,DynamicBind,7POM_7VZ,0.5,0.8,"{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+821,DynamicBind,7M31_TDR,,0.0,,
+822,DynamicBind,8EYE_X4I,0.31818181818181807,0.8727272727272728,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+823,DynamicBind,6YRV_PJ8,0.40909090909090906,0.8363636363636364,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+824,DynamicBind,7LZD_YHY,0.30434782608695654,0.8782608695652174,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+825,DynamicBind,7EPV_FDA,0.3703703703703704,0.8518518518518519,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 3, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+826,DynamicBind,7UY4_SMI,0.4285714285714285,0.8285714285714286,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+827,DynamicBind,7N4N_0BK,0.23529411764705874,0.9058823529411765,"{'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+828,DynamicBind,7UMW_NAD,0.5357142857142856,0.7857142857142858,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+829,DynamicBind,7U3J_L6U,0.4399999999999999,0.8240000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+830,DynamicBind,6Z14_Q4Z,0.25,0.9,"{'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+831,DynamicBind,6ZK5_IMH,0.5263157894736843,0.7894736842105263,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+832,DynamicBind,7QGP_DJ8,,0.0,,
+833,DynamicBind,7L5F_XNG,0.3157894736842105,0.8736842105263158,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+834,DynamicBind,7FT9_4MB,,0.0,,
+835,DynamicBind,7OP9_06K,,0.0,,
+836,DynamicBind,7JXX_VP7,0.24000000000000005,0.904,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+837,DynamicBind,7CL8_TES,0.6428571428571429,0.7428571428571429,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+838,DynamicBind,7TM6_GPJ,0.75,0.7,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LYS:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+839,DynamicBind,7WQQ_5Z6,0.5555555555555555,0.7777777777777778,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+840,DynamicBind,7WL4_JFU,0.3157894736842105,0.8736842105263158,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+841,DynamicBind,7SCW_GSP,0.3043478260869565,0.8782608695652174,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+842,DynamicBind,7L7C_XQ1,0.2666666666666666,0.8933333333333333,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+843,DynamicBind,7PUV_84Z,0.0625,0.975,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+844,DynamicBind,7KQU_YOF,0.4736842105263159,0.8105263157894737,"{'UNL:HIS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+845,DynamicBind,7Z2O_IAJ,0.1666666666666666,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+846,DynamicBind,7PRM_81I,0.3809523809523808,0.8476190476190477,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+847,DynamicBind,8FLV_ZB9,,0.0,,
+848,DynamicBind,7NLV_UJE,0.5,0.8,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+849,DynamicBind,7T0D_FPP,,0.0,,
+850,DynamicBind,7MWU_ZPM,0.08333333333333337,0.9666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+851,DynamicBind,7L00_XCJ,0.23809523809523814,0.9047619047619048,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+852,DynamicBind,8C5M_MTA,,0.0,,
+853,DynamicBind,7Z7F_IF3,0.1333333333333333,0.9466666666666667,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+854,DynamicBind,7TSF_H4B,0.36363636363636365,0.8545454545454545,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+855,DynamicBind,7TUO_KL9,0.2916666666666667,0.8833333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+856,DynamicBind,7ED2_A3P,0.65,0.74,"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+857,DynamicBind,7ZL5_IWE,0.6470588235294117,0.7411764705882353,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+858,DynamicBind,8F8E_XJI,0.5,0.8,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+859,DynamicBind,7OZC_G6S,0.23529411764705885,0.9058823529411765,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+860,DynamicBind,7Q2B_M6H,0.33333333333333337,0.8666666666666667,"{'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+861,DynamicBind,6VTA_AKN,0.55,0.78,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+862,DynamicBind,7V3N_AKG,0.6470588235294118,0.7411764705882353,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+863,DynamicBind,8F4J_PHO,,0.0,,
+864,DynamicBind,7ZOC_T8E,0.2666666666666666,0.8933333333333333,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+865,DynamicBind,7WCF_ACP,0.07142857142857156,0.9714285714285714,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+866,DynamicBind,7NUT_GLP,0.3529411764705882,0.8588235294117648,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}"
+867,DynamicBind,7E4L_MDN,0.6666666666666666,0.7333333333333334,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+868,DynamicBind,7TS6_KMI,0.0,1.0,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+869,DynamicBind,7NF3_4LU,0.30555555555555547,0.8777777777777778,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+870,DynamicBind,8D5D_5DK,0.4074074074074075,0.837037037037037,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+871,DynamicBind,7JMV_4NC,0.19047619047619047,0.9238095238095239,"{'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+872,DynamicBind,7A9E_R4W,0.46153846153846145,0.8153846153846154,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+873,DynamicBind,7TBU_S3P,0.2,0.92,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+874,DynamicBind,7TB0_UD1,,0.0,,
+875,DynamicBind,7MFP_Z7P,,0.0,,
+876,DynamicBind,6M2B_EZO,0.42307692307692313,0.8307692307692307,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+877,DynamicBind,7NPL_UKZ,0.5185185185185184,0.7925925925925926,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+878,DynamicBind,7KZ9_XN7,0.7,0.72,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+879,DynamicBind,7QE4_NGA,,0.0,,
+880,DynamicBind,8AP0_PRP,,0.0,,
+881,DynamicBind,7V3S_5I9,,0.0,,
+882,DynamicBind,7C0U_FGO,0.20833333333333331,0.9166666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}"
+883,DynamicBind,7UXS_OJC,0.8421052631578946,0.6631578947368422,"{'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+884,DynamicBind,7X9K_8OG,,0.0,,
+885,DynamicBind,8BOM_QU6,0.19230769230769226,0.9230769230769231,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+886,DynamicBind,8BTI_RFO,0.05882352941176472,0.9764705882352941,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+887,DynamicBind,7RWS_4UR,0.2222222222222222,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+888,DynamicBind,6YQV_8K2,0.0,1.0,"{'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+889,DynamicBind,7PK0_BYC,0.21052631578947367,0.9157894736842105,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+890,DynamicBind,5SIS_JSM,0.24999999999999994,0.9,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+891,DynamicBind,7NSW_HC4,0.4761904761904761,0.8095238095238095,"{'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+892,DynamicBind,7F8T_FAD,0.17500000000000004,0.9299999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+893,DynamicBind,5SD5_HWI,0.19047619047619047,0.9238095238095239,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+894,DynamicBind,7CUO_PHB,0.125,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+895,DynamicBind,7R3D_APR,,0.0,,
+896,DynamicBind,7WJB_BGC,0.09090909090909083,0.9636363636363636,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+897,DynamicBind,7A1P_QW2,,0.0,,
+898,DynamicBind,6ZPB_3D1,0.4736842105263157,0.8105263157894738,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+899,DynamicBind,7UTW_NAI,0.3333333333333332,0.8666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+900,DynamicBind,7WUY_76N,,0.0,,
+901,DynamicBind,8A2D_KXY,,0.0,,
+902,DynamicBind,7NR8_UOE,0.11538461538461531,0.9538461538461539,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+903,DynamicBind,7KC5_BJZ,0.7857142857142857,0.6857142857142857,"{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+904,DynamicBind,7QPP_VDX,0.5,0.8,"{'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+905,DynamicBind,7VKZ_NOJ,0.5,0.8,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+906,DynamicBind,7F51_BA7,0.48275862068965514,0.806896551724138,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}"
+907,DynamicBind,7PL1_SFG,0.3809523809523809,0.8476190476190477,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+908,DynamicBind,7VB8_STL,0.39130434782608703,0.8434782608695652,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+909,DynamicBind,8FAV_4Y5,0.3214285714285714,0.8714285714285714,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+910,DynamicBind,7CD9_FVR,0.3478260869565218,0.8608695652173912,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}"
+911,DynamicBind,7N7H_CTP,0.5185185185185186,0.7925925925925925,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+912,DynamicBind,7ODY_DGI,,0.0,,
+913,DynamicBind,8CSD_C5P,0.6666666666666667,0.7333333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+914,DynamicBind,7OFK_VCH,0.22727272727272724,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+915,DynamicBind,7SDD_4IP,0.6428571428571429,0.7428571428571429,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+916,DynamicBind,7OPG_06N,,0.0,,
+917,DynamicBind,7ZTL_BCN,0.29999999999999993,0.88,"{'UNL:LEU:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+918,DynamicBind,7SIU_9ID,0.2,0.92,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+919,DynamicBind,7LCU_XTA,0.8235294117647058,0.6705882352941177,"{'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+920,DynamicBind,7NGW_UAW,0.15789473684210525,0.9368421052631579,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+921,DynamicBind,7VYJ_CA0,,0.0,,
+922,DynamicBind,7QHG_T3B,0.4444444444444445,0.8222222222222222,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+923,DynamicBind,8HO0_3ZI,0.5333333333333333,0.7866666666666666,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+924,NeuralPLexer,8AAU_LH0,0.2222222222222222,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+925,NeuralPLexer,7JHQ_VAJ,0.5,0.8,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+926,NeuralPLexer,6ZCY_QF8,0.30000000000000004,0.88,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+927,NeuralPLexer,7UAW_MF6,0.3076923076923076,0.8769230769230769,"{'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+928,NeuralPLexer,6YMS_OZH,0.409090909090909,0.8363636363636364,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+929,NeuralPLexer,7UJ5_DGL,0.15,0.94,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+930,NeuralPLexer,8EX2_Q2Q,,0.0,,
+931,NeuralPLexer,7R9N_F97,0.5555555555555556,0.7777777777777778,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 5, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+932,NeuralPLexer,7UYB_OK0,0.10526315789473678,0.9578947368421052,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+933,NeuralPLexer,7U0U_FK5,0.3846153846153847,0.8461538461538461,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+934,NeuralPLexer,7ZU2_DHT,0.4666666666666667,0.8133333333333334,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 5, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+935,NeuralPLexer,6XHT_V2V,0.5555555555555557,0.7777777777777777,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+936,NeuralPLexer,7OSO_0V1,0.4,0.84,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+937,NeuralPLexer,8D19_GSH,0.17647058823529416,0.9294117647058824,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+938,NeuralPLexer,7MGT_ZD4,0.5416666666666667,0.7833333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+939,NeuralPLexer,8C3N_ADP,0.5294117647058824,0.788235294117647,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+940,NeuralPLexer,6YYO_Q1K,1.0,0.6,"{'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+941,NeuralPLexer,8A1H_DLZ,0.7142857142857143,0.7142857142857143,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+942,NeuralPLexer,7XQZ_FPF,0.22727272727272718,0.9090909090909092,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+943,NeuralPLexer,7RH3_59O,0.41666666666666663,0.8333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+944,NeuralPLexer,7OMX_CNA,0.7407407407407408,0.7037037037037037,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+945,NeuralPLexer,7LMO_NYO,0.15999999999999998,0.936,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+946,NeuralPLexer,7VBU_6I4,0.8571428571428572,0.6571428571428571,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+947,NeuralPLexer,7TXK_LW8,0.3125,0.875,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+948,NeuralPLexer,7T1D_E7K,0.4782608695652174,0.808695652173913,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 7, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+949,NeuralPLexer,7R59_I5F,0.09090909090909088,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+950,NeuralPLexer,7ZCC_OGA,0.45454545454545453,0.8181818181818181,"{'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+951,NeuralPLexer,7V43_C4O,0.6666666666666666,0.7333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+952,NeuralPLexer,7BNH_BEZ,0.875,0.65,"{'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+953,NeuralPLexer,6WTN_RXT,0.11111111111111113,0.9555555555555555,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+954,NeuralPLexer,7QFM_AY3,0.11764705882352944,0.9529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+955,NeuralPLexer,7MSR_DCA,0.8260869565217391,0.6695652173913044,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+956,NeuralPLexer,5SAK_ZRY,,0.0,,
+957,NeuralPLexer,7QTA_URI,1.0,0.6,{},"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+958,NeuralPLexer,7RSV_7IQ,0.8333333333333334,0.6666666666666666,"{'UNL:ASP:VdWContact': 3, 'UNL:HIS:VdWContact': 1}","{'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+959,NeuralPLexer,8DSC_NCA,0.5714285714285714,0.7714285714285715,"{'UNL:ARG:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+960,NeuralPLexer,7AKL_RK5,0.2857142857142856,0.8857142857142858,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+961,NeuralPLexer,7XBV_APC,0.3000000000000001,0.88,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+962,NeuralPLexer,7CNS_PMV,0.7142857142857144,0.7142857142857142,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+963,NeuralPLexer,7ZDY_6MJ,0.1111111111111111,0.9555555555555556,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+964,NeuralPLexer,6Z4N_Q7B,0.6470588235294118,0.7411764705882353,"{'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+965,NeuralPLexer,7NFB_GEN,0.3529411764705882,0.8588235294117648,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+966,NeuralPLexer,7R7R_AWJ,0.5555555555555557,0.7777777777777777,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+967,NeuralPLexer,7V14_ORU,0.22727272727272724,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+968,NeuralPLexer,6YR2_T1C,0.26315789473684215,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+969,NeuralPLexer,7JG0_GAR,0.3076923076923077,0.8769230769230769,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:V:VdWContact': 1}"
+970,NeuralPLexer,7EBG_J0L,0.7,0.72,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+971,NeuralPLexer,8AY3_OE3,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+972,NeuralPLexer,7M6K_YRJ,0.5000000000000001,0.7999999999999999,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+973,NeuralPLexer,6YT6_PKE,0.35,0.86,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+974,NeuralPLexer,7Q27_8KC,0.29166666666666663,0.8833333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+975,NeuralPLexer,8DHG_T78,0.5789473684210527,0.7684210526315789,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+976,NeuralPLexer,8EXL_799,0.6521739130434782,0.7391304347826088,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+977,NeuralPLexer,7FB7_8NF,0.4285714285714286,0.8285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+978,NeuralPLexer,7THI_PGA,0.9166666666666665,0.6333333333333334,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+979,NeuralPLexer,6ZAE_ACV,0.11111111111111113,0.9555555555555555,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+980,NeuralPLexer,7MGY_ZD1,0.05555555555555555,0.9777777777777777,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+981,NeuralPLexer,7XPO_UPG,0.6470588235294117,0.7411764705882353,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+982,NeuralPLexer,7SUC_COM,,0.0,,
+983,NeuralPLexer,7BJJ_TVW,0.11111111111111116,0.9555555555555555,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+984,NeuralPLexer,7K0V_VQP,0.20689655172413787,0.9172413793103449,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+985,NeuralPLexer,7TE8_P0T,0.16666666666666663,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+986,NeuralPLexer,7QF4_RBF,0.4500000000000001,0.82,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+987,NeuralPLexer,7UJ4_OQ4,0.3809523809523808,0.8476190476190477,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+988,NeuralPLexer,7A9H_TPP,0.34782608695652173,0.8608695652173913,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+989,NeuralPLexer,7LEV_0JO,0.3181818181818183,0.8727272727272727,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2}"
+990,NeuralPLexer,7N6F_0I1,0.31578947368421056,0.8736842105263158,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+991,NeuralPLexer,8EAB_VN2,0.7142857142857142,0.7142857142857143,"{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 7, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+992,NeuralPLexer,6ZC3_JOR,0.7142857142857143,0.7142857142857143,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+993,NeuralPLexer,7Q25_8J9,,0.0,,
+994,NeuralPLexer,7C3U_AZG,0.30769230769230765,0.8769230769230769,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2}"
+995,NeuralPLexer,7ROR_69X,0.5000000000000001,0.7999999999999999,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+996,NeuralPLexer,7MMH_ZJY,0.4827586206896552,0.806896551724138,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+997,NeuralPLexer,7TH4_FFO,0.5625,0.775,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+998,NeuralPLexer,8D39_QDB,0.23076923076923084,0.9076923076923077,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+999,NeuralPLexer,7YZU_DO7,0.4000000000000001,0.84,"{'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+1000,NeuralPLexer,5SB2_1K2,0.2692307692307692,0.8923076923076924,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1001,NeuralPLexer,6M73_FNR,0.2857142857142857,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1002,NeuralPLexer,8B8H_OJQ,0.2857142857142858,0.8857142857142857,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+1003,NeuralPLexer,7TOM_5AD,0.5217391304347827,0.7913043478260869,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1004,NeuralPLexer,7VWF_K55,0.3076923076923078,0.8769230769230769,"{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+1005,NeuralPLexer,7XI7_4RI,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1006,NeuralPLexer,7AN5_RDH,0.7142857142857144,0.7142857142857142,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+1007,NeuralPLexer,7B2C_TP7,,0.0,,
+1008,NeuralPLexer,7B94_ANP,0.12000000000000005,0.952,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1009,NeuralPLexer,7NF0_BYN,0.45161290322580644,0.8193548387096774,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}"
+1010,NeuralPLexer,7WKL_CAQ,0.0,1.0,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1011,NeuralPLexer,7WPW_F15,0.2380952380952382,0.9047619047619048,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1012,NeuralPLexer,8SLG_G5A,0.6666666666666666,0.7333333333333334,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1013,NeuralPLexer,7RNI_60I,,0.0,,
+1014,NeuralPLexer,7SZA_DUI,0.36842105263157887,0.8526315789473684,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1015,NeuralPLexer,7PIH_7QW,0.18181818181818174,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1016,NeuralPLexer,7T3E_SLB,0.9285714285714285,0.6285714285714286,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+1017,NeuralPLexer,7FRX_O88,,0.0,,
+1018,NeuralPLexer,8CNH_V6U,0.2631578947368421,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+1019,NeuralPLexer,7C8Q_DSG,,0.0,,
+1020,NeuralPLexer,7ZF0_DHR,0.25,0.9,"{'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3}"
+1021,NeuralPLexer,8G0V_YHT,0.30434782608695654,0.8782608695652174,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1022,NeuralPLexer,7P5T_5YG,0.6363636363636365,0.7454545454545454,"{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1023,NeuralPLexer,7NU0_DCL,0.08333333333333334,0.9666666666666667,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1024,NeuralPLexer,6Z0R_Q4H,0.4615384615384617,0.8153846153846154,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}"
+1025,NeuralPLexer,7XRL_FWK,0.3125,0.875,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1026,NeuralPLexer,7LOU_IFM,0.41666666666666674,0.8333333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:UDP:VdWContact': 1}"
+1027,NeuralPLexer,7ROU_66I,0.8275862068965517,0.6689655172413793,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1028,NeuralPLexer,6XCT_478,0.380952380952381,0.8476190476190476,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1029,NeuralPLexer,7LT0_ONJ,0.2727272727272727,0.8909090909090909,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+1030,NeuralPLexer,7OLI_8HG,0.1499999999999999,0.9400000000000001,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+1031,NeuralPLexer,7Z1Q_NIO,0.27272727272727276,0.8909090909090909,"{'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1032,NeuralPLexer,6YQW_82I,0.16666666666666666,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1033,NeuralPLexer,6T88_MWQ,0.5384615384615383,0.7846153846153847,"{'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1034,NeuralPLexer,7PRI_7TI,0.41176470588235287,0.8352941176470589,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1}"
+1035,NeuralPLexer,7OFF_VCB,0.5333333333333333,0.7866666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1036,NeuralPLexer,7DQL_4CL,0.5454545454545454,0.7818181818181819,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+1037,NeuralPLexer,7O1T_5X8,0.24000000000000005,0.904,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1038,NeuralPLexer,7KM8_WPD,0.45000000000000007,0.82,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1039,NeuralPLexer,7ZXV_45D,0.40740740740740744,0.837037037037037,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL::Hydrophobic': 1, 'UNL::VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1040,NeuralPLexer,7X5N_5M5,0.08333333333333326,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1041,NeuralPLexer,7VQ9_ISY,0.8125,0.675,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+1042,NeuralPLexer,7PJQ_OWH,0.1538461538461538,0.9384615384615385,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1043,NeuralPLexer,8AQL_PLG,0.10526315789473678,0.9578947368421052,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1044,NeuralPLexer,7VC5_9SF,0.35714285714285715,0.8571428571428572,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1045,NeuralPLexer,7AFX_R9K,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+1046,NeuralPLexer,7RKW_5TV,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1047,NeuralPLexer,7TYP_KUR,0.4285714285714285,0.8285714285714286,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 6, 'UNL:VAL:VdWContact': 5}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1048,NeuralPLexer,7L03_F9F,0.08333333333333348,0.9666666666666666,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1049,NeuralPLexer,7P1F_KFN,1.0,0.6,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1050,NeuralPLexer,7O0N_CDP,0.625,0.75,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1051,NeuralPLexer,7MYU_ZR7,0.2727272727272727,0.8909090909090909,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1052,NeuralPLexer,6YSP_PAL,1.2941176470588234,0.48235294117647065,"{'UNL:ARG:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+1053,NeuralPLexer,7XJN_NSD,0.909090909090909,0.6363636363636365,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1054,NeuralPLexer,7R6J_2I7,0.3478260869565218,0.8608695652173912,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1055,NeuralPLexer,8HFN_XGC,0.5454545454545454,0.7818181818181819,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1056,NeuralPLexer,7BTT_F8R,0.125,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1057,NeuralPLexer,7MY1_IPE,0.38888888888888895,0.8444444444444444,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+1058,NeuralPLexer,8FO5_Y4U,0.6,0.76,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 3}","{'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}"
+1059,NeuralPLexer,8AUH_L9I,0.2666666666666667,0.8933333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1060,NeuralPLexer,7ECR_SIN,0.5384615384615383,0.7846153846153847,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1061,NeuralPLexer,6TW5_9M2,0.17647058823529416,0.9294117647058824,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1062,NeuralPLexer,7ELT_TYM,0.3666666666666666,0.8533333333333334,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}"
+1063,NeuralPLexer,7D5C_GV6,0.22222222222222227,0.9111111111111111,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1064,NeuralPLexer,7W06_ITN,0.5,0.8,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+1065,NeuralPLexer,6YJA_2BA,0.20833333333333337,0.9166666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1066,NeuralPLexer,7P1M_4IU,0.7499999999999998,0.7000000000000001,"{'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+1067,NeuralPLexer,7PGX_FMN,0.28571428571428564,0.8857142857142858,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+1068,NeuralPLexer,7UAS_MBU,0.25000000000000006,0.9,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+1069,NeuralPLexer,8GFD_ZHR,0.1875,0.925,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1070,NeuralPLexer,7CTM_BDP,0.6666666666666666,0.7333333333333334,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CSD:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1}"
+1071,NeuralPLexer,7UQ3_O2U,0.5,0.8,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1072,NeuralPLexer,7DKT_GLF,0.5454545454545454,0.7818181818181819,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+1073,NeuralPLexer,7CNQ_G8X,,0.0,,
+1074,NeuralPLexer,6Z1C_7EY,0.3125,0.875,"{'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}"
+1075,NeuralPLexer,7M3H_YPV,0.7857142857142859,0.6857142857142856,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1}"
+1076,NeuralPLexer,7D6O_MTE,,0.0,,
+1077,NeuralPLexer,7N4W_P4V,0.4117647058823529,0.8352941176470589,"{'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1078,NeuralPLexer,6Z2C_Q5E,0.3846153846153846,0.8461538461538461,"{'UNL:ARG:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1079,NeuralPLexer,7CIJ_G0C,0.2000000000000001,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2}"
+1080,NeuralPLexer,7USH_82V,0.4285714285714285,0.8285714285714286,"{'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+1081,NeuralPLexer,7XG5_PLP,0.23529411764705885,0.9058823529411765,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+1082,NeuralPLexer,7PT3_3KK,0.3750000000000001,0.85,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 3, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1083,NeuralPLexer,7KB1_WBJ,0.4,0.84,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+1084,NeuralPLexer,7WUX_6OI,,0.0,,
+1085,NeuralPLexer,7OZ9_NGK,0.875,0.65,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+1086,NeuralPLexer,7N03_ZRP,0.4736842105263159,0.8105263157894737,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1087,NeuralPLexer,7BMI_U4B,1.0,0.6,"{'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1088,NeuralPLexer,7RZL_NPO,0.25,0.9,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1089,NeuralPLexer,7QHL_D5P,0.38095238095238104,0.8476190476190476,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 3, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1090,NeuralPLexer,7N7B_T3F,0.3181818181818181,0.8727272727272728,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1091,NeuralPLexer,7Q5I_I0F,0.12,0.952,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+1092,NeuralPLexer,7BKA_4JC,0.11764705882352944,0.9529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1093,NeuralPLexer,7NXO_UU8,0.09090909090909094,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1094,NeuralPLexer,6XG5_TOP,0.25,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+1095,NeuralPLexer,6XBO_5MC,0.9999999999999999,0.6000000000000001,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+1096,NeuralPLexer,8DKO_TFB,0.2727272727272727,0.8909090909090909,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1097,NeuralPLexer,7LJN_GTP,0.4210526315789473,0.8315789473684211,"{'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1098,NeuralPLexer,7MOI_HPS,0.41666666666666674,0.8333333333333333,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}"
+1099,NeuralPLexer,8G6P_API,0.5333333333333334,0.7866666666666666,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+1100,NeuralPLexer,7ULC_56B,0.27272727272727265,0.890909090909091,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1101,NeuralPLexer,7RC3_SAH,0.17391304347826086,0.9304347826086956,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1102,NeuralPLexer,7SFO_98L,0.5263157894736841,0.7894736842105263,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 4, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+1103,NeuralPLexer,8DP2_UMA,0.28,0.888,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+1104,NeuralPLexer,7ZZW_KKW,1.1875,0.525,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+1105,NeuralPLexer,7XFA_D9J,0.14285714285714285,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+1106,NeuralPLexer,7NP6_UK8,0.5357142857142857,0.7857142857142857,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1107,NeuralPLexer,7F5D_EUO,0.2666666666666667,0.8933333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1108,NeuralPLexer,6TW7_NZB,0.2666666666666666,0.8933333333333333,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1109,NeuralPLexer,7FHA_ADX,0.40000000000000013,0.84,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+1110,NeuralPLexer,7ES1_UDP,0.19999999999999998,0.92,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1111,NeuralPLexer,7OEO_V9Z,0.16666666666666669,0.9333333333333333,"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+1112,NeuralPLexer,7DUA_HJ0,1.0,0.6,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1113,NeuralPLexer,7BCP_GCO,0.4000000000000001,0.84,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+1114,NeuralPLexer,7P2I_MFU,0.5454545454545454,0.7818181818181819,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}"
+1115,NeuralPLexer,7WDT_NGS,1.0,0.6,"{'UNL:ASP:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1116,NeuralPLexer,8AEM_LVF,0.6153846153846154,0.7538461538461538,"{'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1117,NeuralPLexer,7WY1_D0L,0.39999999999999997,0.8400000000000001,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1118,NeuralPLexer,7KRU_ATP,0.25000000000000006,0.9,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 5, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}"
+1119,NeuralPLexer,7P4C_5OV,0.5000000000000001,0.7999999999999999,"{'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 2}"
+1120,NeuralPLexer,7MWN_WI5,0.22727272727272735,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+1121,NeuralPLexer,7ZHP_IQY,0.2800000000000001,0.888,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1122,NeuralPLexer,7W05_GMP,0.8461538461538461,0.6615384615384615,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+1123,NeuralPLexer,7UJF_R3V,0.4999999999999999,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1124,NeuralPLexer,7LOE_Y84,0.5,0.8,"{'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+1125,NeuralPLexer,8AIE_M7L,0.47058823529411764,0.8117647058823529,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1126,NeuralPLexer,7JY3_VUD,0.1111111111111111,0.9555555555555556,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1127,NeuralPLexer,6XM9_V55,0.0,1.0,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1128,NeuralPLexer,7POM_7VZ,0.2631578947368422,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1129,NeuralPLexer,7M31_TDR,,0.0,,
+1130,NeuralPLexer,8EYE_X4I,0.4347826086956523,0.826086956521739,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:Hydrophobic': 3, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1131,NeuralPLexer,6YRV_PJ8,0.20833333333333331,0.9166666666666666,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1132,NeuralPLexer,7LZD_YHY,0.22222222222222227,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1133,NeuralPLexer,7EPV_FDA,0.41666666666666663,0.8333333333333334,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+1134,NeuralPLexer,7UY4_SMI,0.3571428571428571,0.8571428571428572,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1135,NeuralPLexer,7N4N_0BK,0.4666666666666668,0.8133333333333332,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1136,NeuralPLexer,7UMW_NAD,0.16666666666666663,0.9333333333333333,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1137,NeuralPLexer,7U3J_L6U,0.8461538461538461,0.6615384615384615,"{'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+1138,NeuralPLexer,6Z14_Q4Z,0.41666666666666674,0.8333333333333333,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1139,NeuralPLexer,6ZK5_IMH,0.42105263157894735,0.8315789473684211,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1140,NeuralPLexer,7QGP_DJ8,0.2727272727272727,0.8909090909090909,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1141,NeuralPLexer,7L5F_XNG,0.7777777777777778,0.6888888888888889,"{'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1142,NeuralPLexer,7FT9_4MB,0.6,0.76,"{'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+1143,NeuralPLexer,7OP9_06K,,0.0,,
+1144,NeuralPLexer,7JXX_VP7,0.375,0.85,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1145,NeuralPLexer,7CL8_TES,0.6666666666666666,0.7333333333333334,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1146,NeuralPLexer,7TM6_GPJ,0.8571428571428572,0.6571428571428571,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+1147,NeuralPLexer,7WQQ_5Z6,0.3529411764705883,0.8588235294117647,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1148,NeuralPLexer,7WL4_JFU,0.15000000000000005,0.94,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1149,NeuralPLexer,7SCW_GSP,0.1071428571428571,0.9571428571428572,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1150,NeuralPLexer,7L7C_XQ1,0.2666666666666667,0.8933333333333333,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 3, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+1151,NeuralPLexer,7PUV_84Z,0.1764705882352941,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1152,NeuralPLexer,7KQU_YOF,0.42105263157894735,0.8315789473684211,"{'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1153,NeuralPLexer,7Z2O_IAJ,0.30769230769230765,0.8769230769230769,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+1154,NeuralPLexer,7PRM_81I,0.40909090909090906,0.8363636363636364,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1155,NeuralPLexer,8FLV_ZB9,0.13043478260869568,0.9478260869565217,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1156,NeuralPLexer,7NLV_UJE,0.631578947368421,0.7473684210526316,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1157,NeuralPLexer,7T0D_FPP,0.42857142857142866,0.8285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 5}"
+1158,NeuralPLexer,7MWU_ZPM,0.18181818181818177,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1159,NeuralPLexer,7L00_XCJ,0.7,0.72,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1160,NeuralPLexer,8C5M_MTA,0.0,1.0,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1161,NeuralPLexer,7Z7F_IF3,0.4615384615384615,0.8153846153846154,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1162,NeuralPLexer,7TSF_H4B,0.47058823529411764,0.8117647058823529,"{'UNL:ARG:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+1163,NeuralPLexer,7TUO_KL9,0.1071428571428571,0.9571428571428572,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1164,NeuralPLexer,7ED2_A3P,0.611111111111111,0.7555555555555555,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1165,NeuralPLexer,7ZL5_IWE,0.5,0.8,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+1166,NeuralPLexer,8F8E_XJI,0.2608695652173912,0.8956521739130435,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1167,NeuralPLexer,7OZC_G6S,0.6428571428571429,0.7428571428571429,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1168,NeuralPLexer,7Q2B_M6H,0.33333333333333337,0.8666666666666667,"{'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1169,NeuralPLexer,6VTA_AKN,0.5454545454545454,0.7818181818181819,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+1170,NeuralPLexer,7V3N_AKG,0.6470588235294118,0.7411764705882353,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1171,NeuralPLexer,8F4J_PHO,,0.0,,
+1172,NeuralPLexer,7ZOC_T8E,0.6153846153846152,0.7538461538461539,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1173,NeuralPLexer,7WCF_ACP,0.2083333333333333,0.9166666666666667,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1174,NeuralPLexer,7NUT_GLP,0.375,0.85,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}"
+1175,NeuralPLexer,7E4L_MDN,0.5454545454545453,0.7818181818181819,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+1176,NeuralPLexer,7TS6_KMI,0.0714285714285714,0.9714285714285714,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1177,NeuralPLexer,7NF3_4LU,0.4827586206896552,0.806896551724138,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+1178,NeuralPLexer,8D5D_5DK,0.4782608695652173,0.808695652173913,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1179,NeuralPLexer,7JMV_4NC,0.4117647058823529,0.8352941176470589,"{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1180,NeuralPLexer,7A9E_R4W,0.75,0.7,"{'UNL:ARG:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1181,NeuralPLexer,7TBU_S3P,0.2142857142857143,0.9142857142857143,"{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+1182,NeuralPLexer,7TB0_UD1,0.3214285714285715,0.8714285714285714,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+1183,NeuralPLexer,7MFP_Z7P,0.25,0.9,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 5, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+1184,NeuralPLexer,6M2B_EZO,0.3500000000000001,0.86,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1185,NeuralPLexer,7NPL_UKZ,0.4333333333333334,0.8266666666666667,"{'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 4}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1186,NeuralPLexer,7KZ9_XN7,0.5833333333333333,0.7666666666666667,"{'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1187,NeuralPLexer,7QE4_NGA,,0.0,,
+1188,NeuralPLexer,8AP0_PRP,0.6000000000000001,0.76,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1189,NeuralPLexer,7V3S_5I9,0.4782608695652174,0.808695652173913,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+1190,NeuralPLexer,7C0U_FGO,0.5416666666666665,0.7833333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}"
+1191,NeuralPLexer,7UXS_OJC,0.38095238095238093,0.8476190476190476,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+1192,NeuralPLexer,7X9K_8OG,0.3913043478260869,0.8434782608695652,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1193,NeuralPLexer,8BOM_QU6,0.2142857142857143,0.9142857142857143,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1194,NeuralPLexer,8BTI_RFO,0.5333333333333332,0.7866666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1195,NeuralPLexer,7RWS_4UR,0.588235294117647,0.7647058823529412,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1196,NeuralPLexer,6YQV_8K2,0.625,0.75,"{'UNL:ARG:VdWContact': 1, 'UNL:LEU:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1197,NeuralPLexer,7PK0_BYC,0.27586206896551724,0.8896551724137931,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1198,NeuralPLexer,5SIS_JSM,0.09523809523809523,0.9619047619047619,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1199,NeuralPLexer,7NSW_HC4,0.6842105263157896,0.7263157894736841,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 5, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1200,NeuralPLexer,7F8T_FAD,0.37931034482758624,0.8482758620689654,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1201,NeuralPLexer,5SD5_HWI,0.5789473684210525,0.768421052631579,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1202,NeuralPLexer,7CUO_PHB,0.05882352941176472,0.9764705882352941,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1203,NeuralPLexer,7R3D_APR,0.1666666666666667,0.9333333333333333,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+1204,NeuralPLexer,7WJB_BGC,0.1538461538461539,0.9384615384615385,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1205,NeuralPLexer,7A1P_QW2,0.31578947368421045,0.8736842105263158,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1206,NeuralPLexer,6ZPB_3D1,0.375,0.85,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1207,NeuralPLexer,7UTW_NAI,0.37037037037037046,0.8518518518518519,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+1208,NeuralPLexer,7WUY_76N,0.55,0.78,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1209,NeuralPLexer,8A2D_KXY,0.16666666666666663,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+1210,NeuralPLexer,7NR8_UOE,,0.0,,
+1211,NeuralPLexer,7KC5_BJZ,0.2142857142857143,0.9142857142857143,"{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1212,NeuralPLexer,7QPP_VDX,0.3500000000000001,0.86,"{'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1213,NeuralPLexer,7VKZ_NOJ,0.6153846153846154,0.7538461538461538,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+1214,NeuralPLexer,7F51_BA7,0.29629629629629634,0.8814814814814814,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}"
+1215,NeuralPLexer,7PL1_SFG,0.2400000000000001,0.9039999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1216,NeuralPLexer,7VB8_STL,0.2666666666666666,0.8933333333333333,"{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1217,NeuralPLexer,8FAV_4Y5,0.6153846153846153,0.7538461538461538,"{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1218,NeuralPLexer,7CD9_FVR,0.2857142857142857,0.8857142857142857,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}"
+1219,NeuralPLexer,7N7H_CTP,0.16129032258064524,0.9354838709677419,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 4, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1220,NeuralPLexer,7ODY_DGI,0.4,0.84,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2}"
+1221,NeuralPLexer,8CSD_C5P,0.5,0.8,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1222,NeuralPLexer,7OFK_VCH,0.37499999999999994,0.8500000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1223,NeuralPLexer,7SDD_4IP,0.46666666666666656,0.8133333333333334,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+1224,NeuralPLexer,7OPG_06N,0.1428571428571429,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+1225,NeuralPLexer,7ZTL_BCN,0.14285714285714285,0.9428571428571428,"{'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+1226,NeuralPLexer,7SIU_9ID,0.3333333333333334,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1227,NeuralPLexer,7LCU_XTA,0.7368421052631579,0.7052631578947368,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1228,NeuralPLexer,7NGW_UAW,0.4705882352941177,0.8117647058823529,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1229,NeuralPLexer,7VYJ_CA0,0.08695652173913038,0.9652173913043478,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1230,NeuralPLexer,7QHG_T3B,0.5000000000000001,0.7999999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 4, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+1231,NeuralPLexer,8HO0_3ZI,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1232,RFAA,8AAU_LH0,,0.0,,
+1233,RFAA,7JHQ_VAJ,,0.0,,
+1234,RFAA,6ZCY_QF8,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1235,RFAA,7UAW_MF6,,0.0,,
+1236,RFAA,6YMS_OZH,0.27272727272727265,0.890909090909091,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1237,RFAA,7UJ5_DGL,,0.0,,
+1238,RFAA,8EX2_Q2Q,0.1538461538461538,0.9384615384615385,"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1239,RFAA,7R9N_F97,,0.0,,
+1240,RFAA,7UYB_OK0,,0.0,,
+1241,RFAA,7U0U_FK5,0.2413793103448277,0.9034482758620689,"{'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1242,RFAA,7ZU2_DHT,,0.0,,
+1243,RFAA,6XHT_V2V,,0.0,,
+1244,RFAA,7OSO_0V1,,0.0,,
+1245,RFAA,8D19_GSH,,0.0,,
+1246,RFAA,7MGT_ZD4,,0.0,,
+1247,RFAA,8C3N_ADP,0.5,0.8,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1248,RFAA,6YYO_Q1K,,0.0,,
+1249,RFAA,8A1H_DLZ,,0.0,,
+1250,RFAA,7XQZ_FPF,,0.0,,
+1251,RFAA,7RH3_59O,,0.0,,
+1252,RFAA,7OMX_CNA,,0.0,,
+1253,RFAA,7LMO_NYO,0.6999999999999998,0.7200000000000001,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 5, 'UNL:TYR:VdWContact': 5, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1254,RFAA,7VBU_6I4,,0.0,,
+1255,RFAA,7TXK_LW8,,0.0,,
+1256,RFAA,7T1D_E7K,,0.0,,
+1257,RFAA,7R59_I5F,0.29999999999999993,0.88,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1258,RFAA,7ZCC_OGA,,0.0,,
+1259,RFAA,7V43_C4O,0.5714285714285714,0.7714285714285715,"{'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+1260,RFAA,7BNH_BEZ,,0.0,,
+1261,RFAA,6WTN_RXT,0.11764705882352944,0.9529411764705882,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1262,RFAA,7QFM_AY3,,0.0,,
+1263,RFAA,7MSR_DCA,0.7599999999999999,0.6960000000000001,"{'UNL:ALA:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1264,RFAA,5SAK_ZRY,0.7333333333333334,0.7066666666666667,"{'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+1265,RFAA,7QTA_URI,,0.0,,
+1266,RFAA,7RSV_7IQ,,0.0,,
+1267,RFAA,8DSC_NCA,,0.0,,
+1268,RFAA,7AKL_RK5,0.4444444444444444,0.8222222222222222,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+1269,RFAA,7XBV_APC,,0.0,,
+1270,RFAA,7CNS_PMV,,0.0,,
+1271,RFAA,7ZDY_6MJ,,0.0,,
+1272,RFAA,6Z4N_Q7B,,0.0,,
+1273,RFAA,7NFB_GEN,,0.0,,
+1274,RFAA,7R7R_AWJ,,0.0,,
+1275,RFAA,7V14_ORU,,0.0,,
+1276,RFAA,6YR2_T1C,0.050000000000000044,0.98,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1277,RFAA,7JG0_GAR,,0.0,,
+1278,RFAA,7EBG_J0L,0.4705882352941176,0.8117647058823529,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1279,RFAA,8AY3_OE3,,0.0,,
+1280,RFAA,7M6K_YRJ,0.5,0.8,"{'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1281,RFAA,6YT6_PKE,,0.0,,
+1282,RFAA,7Q27_8KC,,0.0,,
+1283,RFAA,8DHG_T78,,0.0,,
+1284,RFAA,8EXL_799,0.39999999999999997,0.8400000000000001,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+1285,RFAA,7FB7_8NF,0.7058823529411765,0.7176470588235294,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+1286,RFAA,7THI_PGA,,0.0,,
+1287,RFAA,6ZAE_ACV,,0.0,,
+1288,RFAA,7MGY_ZD1,,0.0,,
+1289,RFAA,7XPO_UPG,,0.0,,
+1290,RFAA,7SUC_COM,,0.0,,
+1291,RFAA,7BJJ_TVW,,0.0,,
+1292,RFAA,7K0V_VQP,,0.0,,
+1293,RFAA,7TE8_P0T,,0.0,,
+1294,RFAA,7QF4_RBF,,0.0,,
+1295,RFAA,7UJ4_OQ4,,0.0,,
+1296,RFAA,7A9H_TPP,,0.0,,
+1297,RFAA,7LEV_0JO,,0.0,,
+1298,RFAA,7N6F_0I1,,0.0,,
+1299,RFAA,8EAB_VN2,,0.0,,
+1300,RFAA,6ZC3_JOR,0.5294117647058824,0.788235294117647,"{'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1301,RFAA,7Q25_8J9,,0.0,,
+1302,RFAA,7C3U_AZG,0.25,0.9,"{'UNL:ALA:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2}"
+1303,RFAA,7ROR_69X,,0.0,,
+1304,RFAA,7MMH_ZJY,,0.0,,
+1305,RFAA,7TH4_FFO,,0.0,,
+1306,RFAA,8D39_QDB,,0.0,,
+1307,RFAA,7YZU_DO7,,0.0,,
+1308,RFAA,5SB2_1K2,0.4615384615384615,0.8153846153846154,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1309,RFAA,6M73_FNR,,0.0,,
+1310,RFAA,8B8H_OJQ,,0.0,,
+1311,RFAA,7TOM_5AD,0.3636363636363637,0.8545454545454545,"{'UNL:GLN:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1312,RFAA,7VWF_K55,,0.0,,
+1313,RFAA,7XI7_4RI,0.0,1.0,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1314,RFAA,7AN5_RDH,0.19999999999999996,0.92,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+1315,RFAA,7B2C_TP7,,0.0,,
+1316,RFAA,7B94_ANP,,0.0,,
+1317,RFAA,7NF0_BYN,,0.0,,
+1318,RFAA,7WKL_CAQ,,0.0,,
+1319,RFAA,7WPW_F15,,0.0,,
+1320,RFAA,8SLG_G5A,,0.0,,
+1321,RFAA,7RNI_60I,,0.0,,
+1322,RFAA,7SZA_DUI,,0.0,,
+1323,RFAA,7PIH_7QW,0.35,0.86,"{'UNL:GLU:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1324,RFAA,7T3E_SLB,,0.0,,
+1325,RFAA,7FRX_O88,,0.0,,
+1326,RFAA,8CNH_V6U,,0.0,,
+1327,RFAA,7C8Q_DSG,,0.0,,
+1328,RFAA,7ZF0_DHR,,0.0,,
+1329,RFAA,8G0V_YHT,,0.0,,
+1330,RFAA,7P5T_5YG,,0.0,,
+1331,RFAA,7NU0_DCL,,0.0,,
+1332,RFAA,6Z0R_Q4H,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}"
+1333,RFAA,7XRL_FWK,,0.0,,
+1334,RFAA,7LOU_IFM,0.8421052631578947,0.6631578947368422,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 4, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:UDP:VdWContact': 1}"
+1335,RFAA,7ROU_66I,,0.0,,
+1336,RFAA,6XCT_478,,0.0,,
+1337,RFAA,7LT0_ONJ,,0.0,,
+1338,RFAA,7OLI_8HG,0.6190476190476191,0.7523809523809524,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+1339,RFAA,7Z1Q_NIO,0.36363636363636365,0.8545454545454545,"{'UNL:ASN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1340,RFAA,6YQW_82I,,0.0,,
+1341,RFAA,6T88_MWQ,,0.0,,
+1342,RFAA,7PRI_7TI,,0.0,,
+1343,RFAA,7OFF_VCB,,0.0,,
+1344,RFAA,7DQL_4CL,0.25,0.9,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+1345,RFAA,7O1T_5X8,,0.0,,
+1346,RFAA,7KM8_WPD,0.75,0.7,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1347,RFAA,7ZXV_45D,,0.0,,
+1348,RFAA,7X5N_5M5,,0.0,,
+1349,RFAA,7VQ9_ISY,,0.0,,
+1350,RFAA,7PJQ_OWH,,0.0,,
+1351,RFAA,8AQL_PLG,,0.0,,
+1352,RFAA,7VC5_9SF,,0.0,,
+1353,RFAA,7AFX_R9K,,0.0,,
+1354,RFAA,7RKW_5TV,0.23076923076923078,0.9076923076923077,"{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1355,RFAA,7TYP_KUR,1.1739130434782608,0.5304347826086957,"{'UNL:ALA:VdWContact': 3, 'UNL:CYS:VdWContact': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 6, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 4, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 5}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1356,RFAA,7L03_F9F,,0.0,,
+1357,RFAA,7P1F_KFN,0.6086956521739131,0.7565217391304347,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1358,RFAA,7O0N_CDP,,0.0,,
+1359,RFAA,7MYU_ZR7,,0.0,,
+1360,RFAA,6YSP_PAL,,0.0,,
+1361,RFAA,7XJN_NSD,,0.0,,
+1362,RFAA,7R6J_2I7,,0.0,,
+1363,RFAA,8HFN_XGC,0.4,0.84,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1364,RFAA,7BTT_F8R,,0.0,,
+1365,RFAA,7MY1_IPE,0.24999999999999994,0.9,"{'UNL:ARG:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+1366,RFAA,8FO5_Y4U,,0.0,,
+1367,RFAA,8AUH_L9I,0.10526315789473689,0.9578947368421052,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1368,RFAA,7ECR_SIN,,0.0,,
+1369,RFAA,6TW5_9M2,,0.0,,
+1370,RFAA,7ELT_TYM,,0.0,,
+1371,RFAA,7D5C_GV6,0.24000000000000002,0.904,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1372,RFAA,7W06_ITN,,0.0,,
+1373,RFAA,6YJA_2BA,,0.0,,
+1374,RFAA,7P1M_4IU,0.909090909090909,0.6363636363636365,"{'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 6, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 5, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+1375,RFAA,7PGX_FMN,0.4285714285714286,0.8285714285714285,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 4, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+1376,RFAA,7UAS_MBU,,0.0,,
+1377,RFAA,8GFD_ZHR,,0.0,,
+1378,RFAA,7CTM_BDP,0.42857142857142866,0.8285714285714285,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CSD:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1}"
+1379,RFAA,7UQ3_O2U,,0.0,,
+1380,RFAA,7DKT_GLF,,0.0,,
+1381,RFAA,7CNQ_G8X,,0.0,,
+1382,RFAA,6Z1C_7EY,0.7333333333333334,0.7066666666666667,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}"
+1383,RFAA,7M3H_YPV,,0.0,,
+1384,RFAA,7D6O_MTE,,0.0,,
+1385,RFAA,7N4W_P4V,0.46666666666666673,0.8133333333333332,"{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1386,RFAA,6Z2C_Q5E,,0.0,,
+1387,RFAA,7CIJ_G0C,,0.0,,
+1388,RFAA,7USH_82V,,0.0,,
+1389,RFAA,7XG5_PLP,0.4444444444444444,0.8222222222222222,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+1390,RFAA,7PT3_3KK,0.3125,0.875,"{'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 5, 'UNL:ASP:VdWContact': 4, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 5, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1391,RFAA,7KB1_WBJ,,0.0,,
+1392,RFAA,7WUX_6OI,,0.0,,
+1393,RFAA,7OZ9_NGK,,0.0,,
+1394,RFAA,7N03_ZRP,0.04761904761904767,0.9809523809523809,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1395,RFAA,7BMI_U4B,,0.0,,
+1396,RFAA,7RZL_NPO,0.8125,0.675,"{'UNL:ALA:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1397,RFAA,7QHL_D5P,,0.0,,
+1398,RFAA,7N7B_T3F,,0.0,,
+1399,RFAA,7Q5I_I0F,,0.0,,
+1400,RFAA,7BKA_4JC,,0.0,,
+1401,RFAA,7NXO_UU8,,0.0,,
+1402,RFAA,6XG5_TOP,,0.0,,
+1403,RFAA,6XBO_5MC,0.41176470588235287,0.8352941176470589,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+1404,RFAA,8DKO_TFB,,0.0,,
+1405,RFAA,7LJN_GTP,,0.0,,
+1406,RFAA,7MOI_HPS,0.3529411764705882,0.8588235294117648,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}"
+1407,RFAA,8G6P_API,,0.0,,
+1408,RFAA,7ULC_56B,0.6842105263157896,0.7263157894736841,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 5, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1409,RFAA,7RC3_SAH,,0.0,,
+1410,RFAA,7SFO_98L,,0.0,,
+1411,RFAA,8DP2_UMA,,0.0,,
+1412,RFAA,7ZZW_KKW,,0.0,,
+1413,RFAA,7XFA_D9J,,0.0,,
+1414,RFAA,7NP6_UK8,0.7037037037037037,0.7185185185185186,"{'UNL:ALA:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1415,RFAA,7F5D_EUO,,0.0,,
+1416,RFAA,6TW7_NZB,,0.0,,
+1417,RFAA,7FHA_ADX,,0.0,,
+1418,RFAA,7ES1_UDP,,0.0,,
+1419,RFAA,7OEO_V9Z,0.47058823529411764,0.8117647058823529,"{'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+1420,RFAA,7DUA_HJ0,,0.0,,
+1421,RFAA,7BCP_GCO,,0.0,,
+1422,RFAA,7P2I_MFU,0.3125,0.875,"{'UNL:ALA:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}"
+1423,RFAA,7WDT_NGS,,0.0,,
+1424,RFAA,8AEM_LVF,,0.0,,
+1425,RFAA,7WY1_D0L,,0.0,,
+1426,RFAA,7KRU_ATP,,0.0,,
+1427,RFAA,7P4C_5OV,0.33333333333333337,0.8666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 2}"
+1428,RFAA,7MWN_WI5,,0.0,,
+1429,RFAA,7ZHP_IQY,,0.0,,
+1430,RFAA,7W05_GMP,,0.0,,
+1431,RFAA,7UJF_R3V,,0.0,,
+1432,RFAA,7LOE_Y84,0.5000000000000001,0.7999999999999999,"{'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+1433,RFAA,8AIE_M7L,,0.0,,
+1434,RFAA,7JY3_VUD,,0.0,,
+1435,RFAA,6XM9_V55,0.7500000000000001,0.7,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1436,RFAA,7POM_7VZ,,0.0,,
+1437,RFAA,7M31_TDR,,0.0,,
+1438,RFAA,8EYE_X4I,,0.0,,
+1439,RFAA,6YRV_PJ8,,0.0,,
+1440,RFAA,7LZD_YHY,0.6875,0.725,"{'UNL:ARG:VdWContact': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 5, 'UNL:TYR:VdWContact': 4}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1441,RFAA,7EPV_FDA,0.19230769230769224,0.9230769230769231,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+1442,RFAA,7UY4_SMI,0.38888888888888895,0.8444444444444444,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1443,RFAA,7N4N_0BK,0.2777777777777778,0.8888888888888888,"{'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1444,RFAA,7UMW_NAD,0.4642857142857143,0.8142857142857143,"{'UNL:ALA:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1445,RFAA,7U3J_L6U,,0.0,,
+1446,RFAA,6Z14_Q4Z,0.15384615384615385,0.9384615384615385,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1447,RFAA,6ZK5_IMH,,0.0,,
+1448,RFAA,7QGP_DJ8,,0.0,,
+1449,RFAA,7L5F_XNG,0.18181818181818185,0.9272727272727272,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1450,RFAA,7FT9_4MB,,0.0,,
+1451,RFAA,7OP9_06K,,0.0,,
+1452,RFAA,7JXX_VP7,0.24999999999999997,0.9,"{'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1453,RFAA,7CL8_TES,0.26666666666666666,0.8933333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1454,RFAA,7TM6_GPJ,,0.0,,
+1455,RFAA,7WQQ_5Z6,,0.0,,
+1456,RFAA,7WL4_JFU,,0.0,,
+1457,RFAA,7SCW_GSP,,0.0,,
+1458,RFAA,7L7C_XQ1,,0.0,,
+1459,RFAA,7PUV_84Z,,0.0,,
+1460,RFAA,7KQU_YOF,,0.0,,
+1461,RFAA,7Z2O_IAJ,,0.0,,
+1462,RFAA,7PRM_81I,,0.0,,
+1463,RFAA,8FLV_ZB9,0.2727272727272728,0.8909090909090909,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1464,RFAA,7NLV_UJE,,0.0,,
+1465,RFAA,7T0D_FPP,0.5333333333333333,0.7866666666666666,"{'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 5}"
+1466,RFAA,7MWU_ZPM,0.4166666666666667,0.8333333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1467,RFAA,7L00_XCJ,,0.0,,
+1468,RFAA,8C5M_MTA,0.2777777777777778,0.8888888888888888,"{'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1469,RFAA,7Z7F_IF3,0.375,0.85,"{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1470,RFAA,7TSF_H4B,,0.0,,
+1471,RFAA,7TUO_KL9,,0.0,,
+1472,RFAA,7ED2_A3P,,0.0,,
+1473,RFAA,7ZL5_IWE,,0.0,,
+1474,RFAA,8F8E_XJI,0.41666666666666663,0.8333333333333334,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1475,RFAA,7OZC_G6S,,0.0,,
+1476,RFAA,7Q2B_M6H,0.23076923076923073,0.9076923076923077,"{'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1477,RFAA,6VTA_AKN,0.27272727272727265,0.890909090909091,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+1478,RFAA,7V3N_AKG,,0.0,,
+1479,RFAA,8F4J_PHO,,0.0,,
+1480,RFAA,7ZOC_T8E,,0.0,,
+1481,RFAA,7WCF_ACP,,0.0,,
+1482,RFAA,7NUT_GLP,0.523809523809524,0.7904761904761904,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 5, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}"
+1483,RFAA,7E4L_MDN,,0.0,,
+1484,RFAA,7TS6_KMI,,0.0,,
+1485,RFAA,7NF3_4LU,0.5333333333333333,0.7866666666666666,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+1486,RFAA,8D5D_5DK,,0.0,,
+1487,RFAA,7JMV_4NC,,0.0,,
+1488,RFAA,7A9E_R4W,,0.0,,
+1489,RFAA,7TBU_S3P,,0.0,,
+1490,RFAA,7TB0_UD1,,0.0,,
+1491,RFAA,7MFP_Z7P,,0.0,,
+1492,RFAA,6M2B_EZO,0.3181818181818183,0.8727272727272727,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1493,RFAA,7NPL_UKZ,,0.0,,
+1494,RFAA,7KZ9_XN7,,0.0,,
+1495,RFAA,7QE4_NGA,,0.0,,
+1496,RFAA,8AP0_PRP,,0.0,,
+1497,RFAA,7V3S_5I9,,0.0,,
+1498,RFAA,7C0U_FGO,0.782608695652174,0.6869565217391305,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 5, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 5, 'UNL:TYR:VdWContact': 6}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}"
+1499,RFAA,7UXS_OJC,,0.0,,
+1500,RFAA,7X9K_8OG,,0.0,,
+1501,RFAA,8BOM_QU6,,0.0,,
+1502,RFAA,8BTI_RFO,,0.0,,
+1503,RFAA,7RWS_4UR,,0.0,,
+1504,RFAA,6YQV_8K2,0.2727272727272727,0.8909090909090909,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1505,RFAA,7PK0_BYC,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1506,RFAA,5SIS_JSM,0.24999999999999994,0.9,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1507,RFAA,7NSW_HC4,,0.0,,
+1508,RFAA,7F8T_FAD,,0.0,,
+1509,RFAA,5SD5_HWI,,0.0,,
+1510,RFAA,7CUO_PHB,0.15789473684210525,0.9368421052631579,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1511,RFAA,7R3D_APR,,0.0,,
+1512,RFAA,7WJB_BGC,0.5,0.8,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1513,RFAA,7A1P_QW2,,0.0,,
+1514,RFAA,6ZPB_3D1,,0.0,,
+1515,RFAA,7UTW_NAI,,0.0,,
+1516,RFAA,7WUY_76N,,0.0,,
+1517,RFAA,8A2D_KXY,,0.0,,
+1518,RFAA,7NR8_UOE,,0.0,,
+1519,RFAA,7KC5_BJZ,,0.0,,
+1520,RFAA,7QPP_VDX,0.7619047619047621,0.6952380952380952,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1521,RFAA,7VKZ_NOJ,,0.0,,
+1522,RFAA,7F51_BA7,,0.0,,
+1523,RFAA,7PL1_SFG,0.1363636363636363,0.9454545454545454,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1524,RFAA,7VB8_STL,0.30434782608695654,0.8782608695652174,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1525,RFAA,8FAV_4Y5,0.7407407407407407,0.7037037037037037,"{'UNL:ALA:VdWContact': 4, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 7, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1526,RFAA,7CD9_FVR,,0.0,,
+1527,RFAA,7N7H_CTP,,0.0,,
+1528,RFAA,7ODY_DGI,0.4827586206896551,0.806896551724138,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 6, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2}"
+1529,RFAA,8CSD_C5P,,0.0,,
+1530,RFAA,7OFK_VCH,,0.0,,
+1531,RFAA,7SDD_4IP,,0.0,,
+1532,RFAA,7OPG_06N,,0.0,,
+1533,RFAA,7ZTL_BCN,0.29999999999999993,0.88,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+1534,RFAA,7SIU_9ID,,0.0,,
+1535,RFAA,7LCU_XTA,0.16666666666666674,0.9333333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1536,RFAA,7NGW_UAW,,0.0,,
+1537,RFAA,7VYJ_CA0,,0.0,,
+1538,RFAA,7QHG_T3B,,0.0,,
+1539,RFAA,8HO0_3ZI,,0.0,,
+1540,Chai-1-Single-Seq,8AAU_LH0,0.21428571428571422,0.9142857142857144,"{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1541,Chai-1-Single-Seq,7JHQ_VAJ,0.5384615384615384,0.7846153846153846,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1542,Chai-1-Single-Seq,6ZCY_QF8,0.09523809523809529,0.9619047619047619,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1543,Chai-1-Single-Seq,7UAW_MF6,0.36,0.856,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+1544,Chai-1-Single-Seq,6YMS_OZH,0.22727272727272735,0.9090909090909091,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1545,Chai-1-Single-Seq,7UJ5_DGL,0.11111111111111102,0.9555555555555556,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1546,Chai-1-Single-Seq,8EX2_Q2Q,0.30769230769230765,0.8769230769230769,"{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1547,Chai-1-Single-Seq,7R9N_F97,,0.0,,
+1548,Chai-1-Single-Seq,7UYB_OK0,0.2,0.92,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+1549,Chai-1-Single-Seq,7U0U_FK5,0.4074074074074075,0.837037037037037,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1550,Chai-1-Single-Seq,7ZU2_DHT,0.1538461538461538,0.9384615384615385,"{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 5, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1551,Chai-1-Single-Seq,6XHT_V2V,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+1552,Chai-1-Single-Seq,7OSO_0V1,0.08333333333333337,0.9666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+1553,Chai-1-Single-Seq,8D19_GSH,0.1538461538461538,0.9384615384615385,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+1554,Chai-1-Single-Seq,7MGT_ZD4,0.08695652173913052,0.9652173913043478,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1555,Chai-1-Single-Seq,8C3N_ADP,0.17647058823529413,0.9294117647058824,"{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1556,Chai-1-Single-Seq,6YYO_Q1K,0.29999999999999993,0.88,"{'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+1557,Chai-1-Single-Seq,8A1H_DLZ,0.3000000000000001,0.88,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1558,Chai-1-Single-Seq,7XQZ_FPF,0.08333333333333326,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1559,Chai-1-Single-Seq,7RH3_59O,0.18181818181818185,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+1560,Chai-1-Single-Seq,7OMX_CNA,0.23333333333333334,0.9066666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1561,Chai-1-Single-Seq,7LMO_NYO,0.36363636363636376,0.8545454545454545,"{'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1562,Chai-1-Single-Seq,7VBU_6I4,0.21428571428571425,0.9142857142857143,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1563,Chai-1-Single-Seq,7TXK_LW8,0.1111111111111111,0.9555555555555556,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1564,Chai-1-Single-Seq,7T1D_E7K,0.5,0.8,"{'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 7, 'UNL:PHE:VdWContact': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 7, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1565,Chai-1-Single-Seq,7R59_I5F,0.1,0.96,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1566,Chai-1-Single-Seq,7ZCC_OGA,0.6363636363636364,0.7454545454545455,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1567,Chai-1-Single-Seq,7V43_C4O,0.7142857142857143,0.7142857142857143,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+1568,Chai-1-Single-Seq,7BNH_BEZ,0.25,0.9,"{'UNL:ASP:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+1569,Chai-1-Single-Seq,6WTN_RXT,0.05882352941176472,0.9764705882352941,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1570,Chai-1-Single-Seq,7QFM_AY3,0.21428571428571425,0.9142857142857143,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1571,Chai-1-Single-Seq,7MSR_DCA,0.13043478260869562,0.9478260869565217,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1572,Chai-1-Single-Seq,5SAK_ZRY,0.39999999999999997,0.8400000000000001,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+1573,Chai-1-Single-Seq,7QTA_URI,0.0,1.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+1574,Chai-1-Single-Seq,7RSV_7IQ,0.21428571428571425,0.9142857142857143,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+1575,Chai-1-Single-Seq,8DSC_NCA,,0.0,,
+1576,Chai-1-Single-Seq,7AKL_RK5,0.05882352941176472,0.9764705882352941,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+1577,Chai-1-Single-Seq,7XBV_APC,0.21052631578947373,0.9157894736842105,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1578,Chai-1-Single-Seq,7CNS_PMV,0.26315789473684215,0.8947368421052632,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1579,Chai-1-Single-Seq,7ZDY_6MJ,,0.0,,
+1580,Chai-1-Single-Seq,6Z4N_Q7B,0.41666666666666663,0.8333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+1581,Chai-1-Single-Seq,7NFB_GEN,0.39999999999999997,0.8400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+1582,Chai-1-Single-Seq,7R7R_AWJ,0.38888888888888884,0.8444444444444444,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1583,Chai-1-Single-Seq,7V14_ORU,0.125,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1584,Chai-1-Single-Seq,6YR2_T1C,0.4000000000000001,0.84,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1585,Chai-1-Single-Seq,7JG0_GAR,0.3636363636363637,0.8545454545454545,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:V:VdWContact': 1}"
+1586,Chai-1-Single-Seq,7EBG_J0L,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1587,Chai-1-Single-Seq,8AY3_OE3,0.20000000000000007,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1588,Chai-1-Single-Seq,7M6K_YRJ,0.14999999999999997,0.9400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1589,Chai-1-Single-Seq,6YT6_PKE,,0.0,,
+1590,Chai-1-Single-Seq,7Q27_8KC,0.22222222222222224,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1591,Chai-1-Single-Seq,8DHG_T78,0.14285714285714296,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 5, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1592,Chai-1-Single-Seq,8EXL_799,0.15999999999999998,0.936,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+1593,Chai-1-Single-Seq,7FB7_8NF,0.5,0.8,"{'UNL:ASP:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+1594,Chai-1-Single-Seq,7THI_PGA,0.33333333333333326,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1595,Chai-1-Single-Seq,6ZAE_ACV,0.22222222222222227,0.9111111111111111,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1596,Chai-1-Single-Seq,7MGY_ZD1,,0.0,,
+1597,Chai-1-Single-Seq,7XPO_UPG,0.21052631578947373,0.9157894736842105,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1598,Chai-1-Single-Seq,7SUC_COM,,0.0,,
+1599,Chai-1-Single-Seq,7BJJ_TVW,0.125,0.95,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1600,Chai-1-Single-Seq,7K0V_VQP,0.11111111111111116,0.9555555555555555,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1601,Chai-1-Single-Seq,7TE8_P0T,0.523809523809524,0.7904761904761904,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1602,Chai-1-Single-Seq,7QF4_RBF,0.19999999999999996,0.92,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 4, 'UNL:GLN:HBAcceptor': 3, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+1603,Chai-1-Single-Seq,7UJ4_OQ4,0.10526315789473689,0.9578947368421052,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+1604,Chai-1-Single-Seq,7A9H_TPP,0.27586206896551724,0.8896551724137931,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+1605,Chai-1-Single-Seq,7LEV_0JO,0.09090909090909105,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 4, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2}"
+1606,Chai-1-Single-Seq,7N6F_0I1,0.05263157894736842,0.9789473684210527,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1607,Chai-1-Single-Seq,8EAB_VN2,0.39999999999999997,0.8400000000000001,"{'UNL:ASP:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1608,Chai-1-Single-Seq,6ZC3_JOR,0.2857142857142858,0.8857142857142857,"{'UNL:ARG:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1609,Chai-1-Single-Seq,7Q25_8J9,0.21052631578947384,0.9157894736842105,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 3, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1610,Chai-1-Single-Seq,7C3U_AZG,0.18181818181818185,0.9272727272727272,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2}"
+1611,Chai-1-Single-Seq,7ROR_69X,0.06666666666666665,0.9733333333333334,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1612,Chai-1-Single-Seq,7MMH_ZJY,0.27586206896551724,0.8896551724137931,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1613,Chai-1-Single-Seq,7TH4_FFO,0.2857142857142857,0.8857142857142857,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1614,Chai-1-Single-Seq,8D39_QDB,0.09090909090909094,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1615,Chai-1-Single-Seq,7YZU_DO7,0.04999999999999999,0.98,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+1616,Chai-1-Single-Seq,5SB2_1K2,0.12500000000000006,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1617,Chai-1-Single-Seq,6M73_FNR,0.10714285714285711,0.9571428571428572,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1618,Chai-1-Single-Seq,8B8H_OJQ,0.07407407407407413,0.9703703703703703,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+1619,Chai-1-Single-Seq,7TOM_5AD,0.4090909090909091,0.8363636363636364,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1620,Chai-1-Single-Seq,7VWF_K55,0.19230769230769235,0.923076923076923,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+1621,Chai-1-Single-Seq,7XI7_4RI,0.3076923076923077,0.8769230769230769,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1622,Chai-1-Single-Seq,7AN5_RDH,0.04166666666666663,0.9833333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+1623,Chai-1-Single-Seq,7B2C_TP7,,0.0,,
+1624,Chai-1-Single-Seq,7B94_ANP,0.2,0.92,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1625,Chai-1-Single-Seq,7NF0_BYN,0.25,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}"
+1626,Chai-1-Single-Seq,7WKL_CAQ,0.41666666666666674,0.8333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1627,Chai-1-Single-Seq,7WPW_F15,0.17647058823529416,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1628,Chai-1-Single-Seq,8SLG_G5A,0.3684210526315789,0.8526315789473684,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1629,Chai-1-Single-Seq,7RNI_60I,0.3571428571428571,0.8571428571428572,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 3}"
+1630,Chai-1-Single-Seq,7SZA_DUI,0.26086956521739135,0.8956521739130434,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1631,Chai-1-Single-Seq,7PIH_7QW,0.23809523809523803,0.9047619047619048,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1632,Chai-1-Single-Seq,7T3E_SLB,0.26666666666666666,0.8933333333333333,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+1633,Chai-1-Single-Seq,7FRX_O88,,0.0,,
+1634,Chai-1-Single-Seq,8CNH_V6U,0.35000000000000003,0.86,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+1635,Chai-1-Single-Seq,7C8Q_DSG,0.11111111111111102,0.9555555555555556,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:DSG:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1636,Chai-1-Single-Seq,7ZF0_DHR,,0.0,,
+1637,Chai-1-Single-Seq,8G0V_YHT,,0.0,,
+1638,Chai-1-Single-Seq,7P5T_5YG,0.45454545454545453,0.8181818181818181,"{'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1639,Chai-1-Single-Seq,7NU0_DCL,0.08333333333333326,0.9666666666666667,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1640,Chai-1-Single-Seq,6Z0R_Q4H,0.18181818181818182,0.9272727272727272,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}","{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}"
+1641,Chai-1-Single-Seq,7XRL_FWK,0.1578947368421053,0.9368421052631579,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1642,Chai-1-Single-Seq,7LOU_IFM,0.5454545454545454,0.7818181818181819,"{'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:UDP:VdWContact': 1}"
+1643,Chai-1-Single-Seq,7ROU_66I,0.09677419354838704,0.9612903225806452,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1644,Chai-1-Single-Seq,6XCT_478,0.1578947368421053,0.9368421052631579,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1645,Chai-1-Single-Seq,7LT0_ONJ,0.22222222222222215,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+1646,Chai-1-Single-Seq,7OLI_8HG,0.0,1.0,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+1647,Chai-1-Single-Seq,7Z1Q_NIO,0.09090909090909094,0.9636363636363636,"{'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1648,Chai-1-Single-Seq,6YQW_82I,0.3,0.88,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1649,Chai-1-Single-Seq,6T88_MWQ,0.30769230769230776,0.8769230769230769,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1650,Chai-1-Single-Seq,7PRI_7TI,0.29411764705882354,0.8823529411764706,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1}"
+1651,Chai-1-Single-Seq,7OFF_VCB,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1652,Chai-1-Single-Seq,7DQL_4CL,0.3846153846153846,0.8461538461538461,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+1653,Chai-1-Single-Seq,7O1T_5X8,0.09999999999999994,0.9600000000000001,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1654,Chai-1-Single-Seq,7KM8_WPD,0.14999999999999997,0.9400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1655,Chai-1-Single-Seq,7ZXV_45D,0.3750000000000001,0.85,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL::Hydrophobic': 1, 'UNL::VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1656,Chai-1-Single-Seq,7X5N_5M5,0.05555555555555555,0.9777777777777777,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1657,Chai-1-Single-Seq,7VQ9_ISY,0.4666666666666666,0.8133333333333334,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+1658,Chai-1-Single-Seq,7PJQ_OWH,0.09999999999999998,0.96,"{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1659,Chai-1-Single-Seq,8AQL_PLG,,0.0,,
+1660,Chai-1-Single-Seq,7VC5_9SF,0.6428571428571428,0.7428571428571429,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1661,Chai-1-Single-Seq,7AFX_R9K,0.08333333333333334,0.9666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+1662,Chai-1-Single-Seq,7RKW_5TV,0.2857142857142857,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1663,Chai-1-Single-Seq,7TYP_KUR,0.38461538461538475,0.846153846153846,"{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 5, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1664,Chai-1-Single-Seq,7L03_F9F,0.23529411764705882,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1665,Chai-1-Single-Seq,7P1F_KFN,0.1333333333333333,0.9466666666666667,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1666,Chai-1-Single-Seq,7O0N_CDP,0.2,0.92,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1667,Chai-1-Single-Seq,7MYU_ZR7,0.26086956521739135,0.8956521739130434,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1668,Chai-1-Single-Seq,6YSP_PAL,0.10526315789473684,0.9578947368421052,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+1669,Chai-1-Single-Seq,7XJN_NSD,0.7999999999999999,0.68,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1670,Chai-1-Single-Seq,7R6J_2I7,0.6,0.76,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1671,Chai-1-Single-Seq,8HFN_XGC,0.21739130434782605,0.9130434782608696,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1672,Chai-1-Single-Seq,7BTT_F8R,0.07692307692307698,0.9692307692307692,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1673,Chai-1-Single-Seq,7MY1_IPE,0.2,0.92,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+1674,Chai-1-Single-Seq,8FO5_Y4U,0.8,0.6799999999999999,"{'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4}","{'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}"
+1675,Chai-1-Single-Seq,8AUH_L9I,0.3846153846153847,0.8461538461538461,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1676,Chai-1-Single-Seq,7ECR_SIN,0.7142857142857142,0.7142857142857143,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1677,Chai-1-Single-Seq,6TW5_9M2,0.2857142857142858,0.8857142857142857,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1678,Chai-1-Single-Seq,7ELT_TYM,0.1724137931034484,0.9310344827586207,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}"
+1679,Chai-1-Single-Seq,7D5C_GV6,0.21428571428571427,0.9142857142857143,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1680,Chai-1-Single-Seq,7W06_ITN,0.22222222222222215,0.9111111111111111,"{'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+1681,Chai-1-Single-Seq,6YJA_2BA,0.16666666666666669,0.9333333333333333,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1682,Chai-1-Single-Seq,7P1M_4IU,0.4285714285714287,0.8285714285714285,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+1683,Chai-1-Single-Seq,7PGX_FMN,0.04999999999999993,0.98,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+1684,Chai-1-Single-Seq,7UAS_MBU,0.4117647058823529,0.8352941176470589,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+1685,Chai-1-Single-Seq,8GFD_ZHR,0.055555555555555525,0.9777777777777777,"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1686,Chai-1-Single-Seq,7CTM_BDP,0.33333333333333337,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CSD:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1}"
+1687,Chai-1-Single-Seq,7UQ3_O2U,0.125,0.95,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1688,Chai-1-Single-Seq,7DKT_GLF,0.3333333333333335,0.8666666666666666,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:VdWContact': 4}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+1689,Chai-1-Single-Seq,7CNQ_G8X,,0.0,,
+1690,Chai-1-Single-Seq,6Z1C_7EY,0.14285714285714293,0.9428571428571428,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}"
+1691,Chai-1-Single-Seq,7M3H_YPV,0.3529411764705883,0.8588235294117647,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1}"
+1692,Chai-1-Single-Seq,7D6O_MTE,,0.0,,
+1693,Chai-1-Single-Seq,7N4W_P4V,0.23529411764705885,0.9058823529411765,"{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1694,Chai-1-Single-Seq,6Z2C_Q5E,0.10526315789473684,0.9578947368421052,"{'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1695,Chai-1-Single-Seq,7CIJ_G0C,0.10000000000000003,0.96,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2}"
+1696,Chai-1-Single-Seq,7USH_82V,0.07692307692307687,0.9692307692307692,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+1697,Chai-1-Single-Seq,7XG5_PLP,0.13333333333333341,0.9466666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+1698,Chai-1-Single-Seq,7PT3_3KK,0.3913043478260869,0.8434782608695652,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1699,Chai-1-Single-Seq,7KB1_WBJ,,0.0,,
+1700,Chai-1-Single-Seq,7WUX_6OI,0.2608695652173913,0.8956521739130435,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}"
+1701,Chai-1-Single-Seq,7OZ9_NGK,0.6,0.76,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+1702,Chai-1-Single-Seq,7N03_ZRP,0.1666666666666667,0.9333333333333333,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1703,Chai-1-Single-Seq,7BMI_U4B,0.1333333333333333,0.9466666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1704,Chai-1-Single-Seq,7RZL_NPO,0.10000000000000003,0.96,"{'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1705,Chai-1-Single-Seq,7QHL_D5P,0.0,1.0,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1706,Chai-1-Single-Seq,7N7B_T3F,0.25,0.9,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1707,Chai-1-Single-Seq,7Q5I_I0F,0.409090909090909,0.8363636363636364,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+1708,Chai-1-Single-Seq,7BKA_4JC,0.05882352941176472,0.9764705882352941,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1709,Chai-1-Single-Seq,7NXO_UU8,0.24999999999999997,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1710,Chai-1-Single-Seq,6XG5_TOP,0.08333333333333337,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+1711,Chai-1-Single-Seq,6XBO_5MC,0.05555555555555558,0.9777777777777777,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+1712,Chai-1-Single-Seq,8DKO_TFB,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1713,Chai-1-Single-Seq,7LJN_GTP,0.14999999999999997,0.9400000000000001,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1714,Chai-1-Single-Seq,7MOI_HPS,0.15384615384615385,0.9384615384615385,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}"
+1715,Chai-1-Single-Seq,8G6P_API,0.8666666666666668,0.6533333333333333,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+1716,Chai-1-Single-Seq,7ULC_56B,0.2799999999999999,0.888,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1717,Chai-1-Single-Seq,7RC3_SAH,0.0,1.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1718,Chai-1-Single-Seq,7SFO_98L,0.2631578947368422,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+1719,Chai-1-Single-Seq,8DP2_UMA,0.2173913043478261,0.9130434782608695,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+1720,Chai-1-Single-Seq,7ZZW_KKW,0.2857142857142858,0.8857142857142857,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+1721,Chai-1-Single-Seq,7XFA_D9J,0.16666666666666666,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+1722,Chai-1-Single-Seq,7NP6_UK8,0.5714285714285713,0.7714285714285715,"{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1723,Chai-1-Single-Seq,7F5D_EUO,0.4375,0.825,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1724,Chai-1-Single-Seq,6TW7_NZB,0.4000000000000001,0.84,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1725,Chai-1-Single-Seq,7FHA_ADX,0.0869565217391304,0.9652173913043478,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+1726,Chai-1-Single-Seq,7ES1_UDP,0.21052631578947367,0.9157894736842105,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1727,Chai-1-Single-Seq,7OEO_V9Z,0.21052631578947367,0.9157894736842105,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+1728,Chai-1-Single-Seq,7DUA_HJ0,0.16666666666666669,0.9333333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1729,Chai-1-Single-Seq,7BCP_GCO,0.14285714285714285,0.9428571428571428,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+1730,Chai-1-Single-Seq,7P2I_MFU,0.23076923076923073,0.9076923076923077,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}"
+1731,Chai-1-Single-Seq,7WDT_NGS,0.07142857142857142,0.9714285714285714,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1732,Chai-1-Single-Seq,8AEM_LVF,0.4,0.84,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1733,Chai-1-Single-Seq,7WY1_D0L,0.2500000000000001,0.8999999999999999,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1734,Chai-1-Single-Seq,7KRU_ATP,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 7, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}"
+1735,Chai-1-Single-Seq,7P4C_5OV,0.4,0.84,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 2}"
+1736,Chai-1-Single-Seq,7MWN_WI5,0.047619047619047616,0.9809523809523809,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+1737,Chai-1-Single-Seq,7ZHP_IQY,0.40909090909090906,0.8363636363636364,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1738,Chai-1-Single-Seq,7W05_GMP,0.07692307692307687,0.9692307692307692,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+1739,Chai-1-Single-Seq,7UJF_R3V,0.23809523809523808,0.9047619047619048,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1740,Chai-1-Single-Seq,7LOE_Y84,0.4285714285714286,0.8285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+1741,Chai-1-Single-Seq,8AIE_M7L,0.25,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:VdWContact': 5, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1742,Chai-1-Single-Seq,7JY3_VUD,0.2777777777777778,0.8888888888888888,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1743,Chai-1-Single-Seq,6XM9_V55,0.25000000000000006,0.9,"{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1744,Chai-1-Single-Seq,7POM_7VZ,0.3636363636363636,0.8545454545454545,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1745,Chai-1-Single-Seq,7M31_TDR,,0.0,,
+1746,Chai-1-Single-Seq,8EYE_X4I,0.17391304347826086,0.9304347826086956,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1747,Chai-1-Single-Seq,6YRV_PJ8,0.33333333333333326,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1748,Chai-1-Single-Seq,7LZD_YHY,0.23809523809523808,0.9047619047619048,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1749,Chai-1-Single-Seq,7EPV_FDA,0.125,0.95,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+1750,Chai-1-Single-Seq,7UY4_SMI,0.8181818181818182,0.6727272727272727,"{'UNL:ASN:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1751,Chai-1-Single-Seq,7N4N_0BK,0.5238095238095238,0.7904761904761904,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1752,Chai-1-Single-Seq,7UMW_NAD,0.08333333333333326,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1753,Chai-1-Single-Seq,7U3J_L6U,0.10714285714285723,0.9571428571428571,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+1754,Chai-1-Single-Seq,6Z14_Q4Z,0.2142857142857143,0.9142857142857143,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 4}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1755,Chai-1-Single-Seq,6ZK5_IMH,0.4444444444444444,0.8222222222222222,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1756,Chai-1-Single-Seq,7QGP_DJ8,0.22727272727272735,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1757,Chai-1-Single-Seq,7L5F_XNG,0.19999999999999987,0.92,"{'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1758,Chai-1-Single-Seq,7FT9_4MB,1.1111111111111112,0.5555555555555556,{},"{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+1759,Chai-1-Single-Seq,7OP9_06K,,0.0,,
+1760,Chai-1-Single-Seq,7JXX_VP7,0.4545454545454545,0.8181818181818182,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1761,Chai-1-Single-Seq,7CL8_TES,0.1333333333333333,0.9466666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1762,Chai-1-Single-Seq,7TM6_GPJ,0.07142857142857142,0.9714285714285714,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+1763,Chai-1-Single-Seq,7WQQ_5Z6,0.5625,0.775,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1764,Chai-1-Single-Seq,7WL4_JFU,0.15789473684210525,0.9368421052631579,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1765,Chai-1-Single-Seq,7SCW_GSP,0.1666666666666667,0.9333333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1766,Chai-1-Single-Seq,7L7C_XQ1,0.7142857142857142,0.7142857142857143,"{'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 3, 'UNL:THR:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+1767,Chai-1-Single-Seq,7PUV_84Z,0.4285714285714286,0.8285714285714285,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1768,Chai-1-Single-Seq,7KQU_YOF,,0.0,,
+1769,Chai-1-Single-Seq,7Z2O_IAJ,0.07692307692307698,0.9692307692307692,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+1770,Chai-1-Single-Seq,7PRM_81I,0.13636363636363633,0.9454545454545454,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1771,Chai-1-Single-Seq,8FLV_ZB9,,0.0,,
+1772,Chai-1-Single-Seq,7NLV_UJE,0.2666666666666666,0.8933333333333333,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1773,Chai-1-Single-Seq,7T0D_FPP,0.2666666666666666,0.8933333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 5}"
+1774,Chai-1-Single-Seq,7MWU_ZPM,0.45454545454545453,0.8181818181818181,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1775,Chai-1-Single-Seq,7L00_XCJ,0.27777777777777785,0.8888888888888888,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1776,Chai-1-Single-Seq,8C5M_MTA,0.3333333333333333,0.8666666666666667,"{'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1777,Chai-1-Single-Seq,7Z7F_IF3,0.23076923076923073,0.9076923076923077,"{'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+1778,Chai-1-Single-Seq,7TSF_H4B,0.6111111111111112,0.7555555555555555,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+1779,Chai-1-Single-Seq,7TUO_KL9,0.5,0.8,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1780,Chai-1-Single-Seq,7ED2_A3P,0.22222222222222224,0.9111111111111111,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1781,Chai-1-Single-Seq,7ZL5_IWE,0.4615384615384615,0.8153846153846154,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:VdWContact': 5, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+1782,Chai-1-Single-Seq,8F8E_XJI,0.09999999999999998,0.96,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1783,Chai-1-Single-Seq,7OZC_G6S,0.35714285714285726,0.8571428571428571,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1784,Chai-1-Single-Seq,7Q2B_M6H,0.4117647058823529,0.8352941176470589,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1785,Chai-1-Single-Seq,6VTA_AKN,0.5555555555555556,0.7777777777777778,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+1786,Chai-1-Single-Seq,7V3N_AKG,0.4375,0.825,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1787,Chai-1-Single-Seq,8F4J_PHO,,0.0,,
+1788,Chai-1-Single-Seq,7ZOC_T8E,,0.0,,
+1789,Chai-1-Single-Seq,7WCF_ACP,0.08333333333333333,0.9666666666666667,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1790,Chai-1-Single-Seq,7NUT_GLP,0.1578947368421053,0.9368421052631579,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}"
+1791,Chai-1-Single-Seq,7E4L_MDN,0.4000000000000001,0.84,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+1792,Chai-1-Single-Seq,7TS6_KMI,0.4444444444444444,0.8222222222222222,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1793,Chai-1-Single-Seq,7NF3_4LU,0.12903225806451604,0.9483870967741936,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+1794,Chai-1-Single-Seq,8D5D_5DK,0.19047619047619047,0.9238095238095239,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1795,Chai-1-Single-Seq,7JMV_4NC,0.38888888888888895,0.8444444444444444,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1796,Chai-1-Single-Seq,7A9E_R4W,0.19999999999999996,0.92,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1797,Chai-1-Single-Seq,7TBU_S3P,0.2666666666666667,0.8933333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+1798,Chai-1-Single-Seq,7TB0_UD1,,0.0,,
+1799,Chai-1-Single-Seq,7MFP_Z7P,,0.0,,
+1800,Chai-1-Single-Seq,6M2B_EZO,0.11111111111111102,0.9555555555555556,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1801,Chai-1-Single-Seq,7NPL_UKZ,0.4000000000000001,0.84,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1802,Chai-1-Single-Seq,7KZ9_XN7,0.2727272727272727,0.8909090909090909,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1803,Chai-1-Single-Seq,7QE4_NGA,,0.0,,
+1804,Chai-1-Single-Seq,8AP0_PRP,0.19999999999999996,0.92,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1805,Chai-1-Single-Seq,7V3S_5I9,0.13636363636363646,0.9454545454545454,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+1806,Chai-1-Single-Seq,7C0U_FGO,0.588235294117647,0.7647058823529412,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}"
+1807,Chai-1-Single-Seq,7UXS_OJC,0.4210526315789474,0.831578947368421,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+1808,Chai-1-Single-Seq,7X9K_8OG,0.13636363636363633,0.9454545454545454,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1809,Chai-1-Single-Seq,8BOM_QU6,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1810,Chai-1-Single-Seq,8BTI_RFO,0.06666666666666665,0.9733333333333334,"{'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1811,Chai-1-Single-Seq,7RWS_4UR,0.375,0.85,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1812,Chai-1-Single-Seq,6YQV_8K2,0.15384615384615374,0.9384615384615385,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1813,Chai-1-Single-Seq,7PK0_BYC,0.1666666666666667,0.9333333333333333,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1814,Chai-1-Single-Seq,5SIS_JSM,0.2631578947368421,0.8947368421052632,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1815,Chai-1-Single-Seq,7NSW_HC4,0.09523809523809523,0.9619047619047619,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1816,Chai-1-Single-Seq,7F8T_FAD,0.12500000000000006,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1817,Chai-1-Single-Seq,5SD5_HWI,0.3529411764705882,0.8588235294117648,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1818,Chai-1-Single-Seq,7CUO_PHB,0.05263157894736842,0.9789473684210527,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1819,Chai-1-Single-Seq,7R3D_APR,0.3529411764705882,0.8588235294117648,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 5}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+1820,Chai-1-Single-Seq,7WJB_BGC,0.09090909090909083,0.9636363636363636,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+1821,Chai-1-Single-Seq,7A1P_QW2,0.19047619047619047,0.9238095238095239,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1822,Chai-1-Single-Seq,6ZPB_3D1,0.08695652173913049,0.9652173913043478,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1823,Chai-1-Single-Seq,7UTW_NAI,0.2307692307692308,0.9076923076923077,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+1824,Chai-1-Single-Seq,7WUY_76N,0.5499999999999999,0.78,"{'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1825,Chai-1-Single-Seq,8A2D_KXY,0.2,0.92,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+1826,Chai-1-Single-Seq,7NR8_UOE,0.07407407407407418,0.9703703703703703,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+1827,Chai-1-Single-Seq,7KC5_BJZ,0.6923076923076923,0.7230769230769231,"{'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 4}","{'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1828,Chai-1-Single-Seq,7QPP_VDX,0.3333333333333334,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1829,Chai-1-Single-Seq,7VKZ_NOJ,,0.0,,
+1830,Chai-1-Single-Seq,7F51_BA7,0.16666666666666677,0.9333333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}"
+1831,Chai-1-Single-Seq,7PL1_SFG,0.20000000000000007,0.9199999999999999,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1832,Chai-1-Single-Seq,7VB8_STL,0.21428571428571425,0.9142857142857143,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1833,Chai-1-Single-Seq,8FAV_4Y5,0.7083333333333333,0.7166666666666667,"{'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1834,Chai-1-Single-Seq,7CD9_FVR,0.7999999999999999,0.68,"{'UNL:ASP:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}"
+1835,Chai-1-Single-Seq,7N7H_CTP,0.5909090909090909,0.7636363636363637,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1836,Chai-1-Single-Seq,7ODY_DGI,0.09090909090909086,0.9636363636363636,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2}"
+1837,Chai-1-Single-Seq,8CSD_C5P,0.25,0.9,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1838,Chai-1-Single-Seq,7OFK_VCH,0.1904761904761904,0.9238095238095239,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1839,Chai-1-Single-Seq,7SDD_4IP,0.3846153846153847,0.8461538461538461,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+1840,Chai-1-Single-Seq,7OPG_06N,0.75,0.7,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+1841,Chai-1-Single-Seq,7ZTL_BCN,0.14285714285714285,0.9428571428571428,"{'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+1842,Chai-1-Single-Seq,7SIU_9ID,0.2916666666666666,0.8833333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1843,Chai-1-Single-Seq,7LCU_XTA,0.20833333333333337,0.9166666666666666,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1844,Chai-1-Single-Seq,7NGW_UAW,0.04999999999999993,0.98,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1845,Chai-1-Single-Seq,7VYJ_CA0,0.21052631578947367,0.9157894736842105,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1846,Chai-1-Single-Seq,7QHG_T3B,0.5555555555555555,0.7777777777777778,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+1847,Chai-1-Single-Seq,8HO0_3ZI,0.2,0.92,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1848,Chai-1,8AAU_LH0,0.25,0.9,"{'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1849,Chai-1,7JHQ_VAJ,0.30769230769230765,0.8769230769230769,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1850,Chai-1,6ZCY_QF8,0.09523809523809529,0.9619047619047619,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1851,Chai-1,7UAW_MF6,0.35294117647058826,0.8588235294117648,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+1852,Chai-1,6YMS_OZH,0.1428571428571428,0.9428571428571428,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1853,Chai-1,7UJ5_DGL,0.15,0.94,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1854,Chai-1,8EX2_Q2Q,0.30769230769230765,0.8769230769230769,"{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+1855,Chai-1,7R9N_F97,0.4000000000000001,0.84,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+1856,Chai-1,7UYB_OK0,0.125,0.95,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+1857,Chai-1,7U0U_FK5,0.3214285714285715,0.8714285714285714,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1858,Chai-1,7ZU2_DHT,0.07692307692307687,0.9692307692307692,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1859,Chai-1,6XHT_V2V,0.388888888888889,0.8444444444444443,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+1860,Chai-1,7OSO_0V1,0.30000000000000004,0.88,"{'UNL:ARG:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+1861,Chai-1,8D19_GSH,0.38461538461538464,0.8461538461538461,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+1862,Chai-1,7MGT_ZD4,0.043478260869565216,0.9826086956521739,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1863,Chai-1,8C3N_ADP,0.10526315789473678,0.9578947368421052,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1864,Chai-1,6YYO_Q1K,0.5,0.8,"{'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+1865,Chai-1,8A1H_DLZ,0.09523809523809523,0.9619047619047619,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1866,Chai-1,7XQZ_FPF,0.13636363636363635,0.9454545454545454,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1867,Chai-1,7RH3_59O,0.5,0.8,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+1868,Chai-1,7OMX_CNA,0.090909090909091,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 3, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1869,Chai-1,7LMO_NYO,0.13043478260869582,0.9478260869565217,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1870,Chai-1,7VBU_6I4,0.2857142857142857,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1871,Chai-1,7TXK_LW8,0.5714285714285715,0.7714285714285714,"{'UNL:ASN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1872,Chai-1,7T1D_E7K,,0.0,,
+1873,Chai-1,7R59_I5F,0.18181818181818182,0.9272727272727272,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1874,Chai-1,7ZCC_OGA,0.7272727272727274,0.709090909090909,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+1875,Chai-1,7V43_C4O,0.2,0.92,"{'UNL:ALA:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+1876,Chai-1,7BNH_BEZ,0.14285714285714285,0.9428571428571428,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+1877,Chai-1,6WTN_RXT,0.11764705882352944,0.9529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1878,Chai-1,7QFM_AY3,0.125,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1879,Chai-1,7MSR_DCA,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1880,Chai-1,5SAK_ZRY,0.46666666666666673,0.8133333333333332,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+1881,Chai-1,7QTA_URI,0.25,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+1882,Chai-1,7RSV_7IQ,0.16666666666666669,0.9333333333333333,"{'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+1883,Chai-1,8DSC_NCA,0.2857142857142857,0.8857142857142857,"{'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+1884,Chai-1,7AKL_RK5,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+1885,Chai-1,7XBV_APC,0.22222222222222218,0.9111111111111111,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1886,Chai-1,7CNS_PMV,0.1363636363636364,0.9454545454545454,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1887,Chai-1,7ZDY_6MJ,,0.0,,
+1888,Chai-1,6Z4N_Q7B,0.11764705882352941,0.9529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+1889,Chai-1,7NFB_GEN,0.1875,0.925,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+1890,Chai-1,7R7R_AWJ,0.23529411764705885,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1891,Chai-1,7V14_ORU,0.23529411764705882,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1892,Chai-1,6YR2_T1C,0.3913043478260869,0.8434782608695652,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1893,Chai-1,7JG0_GAR,0.18181818181818182,0.9272727272727272,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:V:VdWContact': 1}"
+1894,Chai-1,7EBG_J0L,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1895,Chai-1,8AY3_OE3,0.17647058823529416,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1896,Chai-1,7M6K_YRJ,0.19999999999999996,0.92,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1897,Chai-1,6YT6_PKE,0.09999999999999998,0.96,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1898,Chai-1,7Q27_8KC,0.4444444444444443,0.8222222222222223,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1899,Chai-1,8DHG_T78,0.1999999999999999,0.92,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 5, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1900,Chai-1,8EXL_799,0.0,1.0,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+1901,Chai-1,7FB7_8NF,0.46153846153846145,0.8153846153846154,"{'UNL:GLU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+1902,Chai-1,7THI_PGA,0.16666666666666674,0.9333333333333333,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1903,Chai-1,6ZAE_ACV,0.16666666666666669,0.9333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1904,Chai-1,7MGY_ZD1,0.05882352941176469,0.9764705882352941,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1905,Chai-1,7XPO_UPG,0.10526315789473678,0.9578947368421052,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+1906,Chai-1,7SUC_COM,,0.0,,
+1907,Chai-1,7BJJ_TVW,0.3000000000000001,0.88,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1908,Chai-1,7K0V_VQP,0.0769230769230771,0.9692307692307691,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1909,Chai-1,7TE8_P0T,0.42857142857142844,0.8285714285714286,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1910,Chai-1,7QF4_RBF,0.2,0.92,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 4, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+1911,Chai-1,7UJ4_OQ4,0.1904761904761904,0.9238095238095239,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+1912,Chai-1,7A9H_TPP,0.15999999999999992,0.936,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+1913,Chai-1,7LEV_0JO,0.19047619047619058,0.9238095238095237,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2}"
+1914,Chai-1,7N6F_0I1,0.23529411764705885,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1915,Chai-1,8EAB_VN2,0.2857142857142857,0.8857142857142857,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1916,Chai-1,6ZC3_JOR,0.35714285714285715,0.8571428571428572,"{'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1917,Chai-1,7Q25_8J9,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 3, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 3, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1918,Chai-1,7C3U_AZG,0.4000000000000001,0.84,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2}"
+1919,Chai-1,7ROR_69X,0.11764705882352941,0.9529411764705882,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1920,Chai-1,7MMH_ZJY,0.17241379310344826,0.9310344827586207,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1921,Chai-1,7TH4_FFO,0.15789473684210525,0.9368421052631579,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1922,Chai-1,8D39_QDB,0.24999999999999994,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1923,Chai-1,7YZU_DO7,0.05555555555555555,0.9777777777777777,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+1924,Chai-1,5SB2_1K2,0.04166666666666674,0.9833333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1925,Chai-1,6M73_FNR,0.07407407407407413,0.9703703703703703,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1926,Chai-1,8B8H_OJQ,0.038461538461538464,0.9846153846153847,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+1927,Chai-1,7TOM_5AD,0.27272727272727276,0.8909090909090909,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1928,Chai-1,7VWF_K55,0.24,0.904,"{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+1929,Chai-1,7XI7_4RI,0.16666666666666669,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1930,Chai-1,7AN5_RDH,0.21739130434782614,0.9130434782608695,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+1931,Chai-1,7B2C_TP7,,0.0,,
+1932,Chai-1,7B94_ANP,0.18181818181818174,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1933,Chai-1,7NF0_BYN,,0.0,,
+1934,Chai-1,7WKL_CAQ,0.38461538461538464,0.8461538461538461,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1935,Chai-1,7WPW_F15,0.0625,0.975,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1936,Chai-1,8SLG_G5A,0.4444444444444444,0.8222222222222222,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+1937,Chai-1,7RNI_60I,0.46153846153846156,0.8153846153846154,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 3}"
+1938,Chai-1,7SZA_DUI,0.26315789473684215,0.8947368421052632,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1939,Chai-1,7PIH_7QW,0.19999999999999996,0.92,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+1940,Chai-1,7T3E_SLB,0.1875,0.925,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+1941,Chai-1,7FRX_O88,,0.0,,
+1942,Chai-1,8CNH_V6U,0.40000000000000013,0.84,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+1943,Chai-1,7C8Q_DSG,0.05555555555555555,0.9777777777777777,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:DSG:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+1944,Chai-1,7ZF0_DHR,0.36363636363636354,0.8545454545454546,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3}"
+1945,Chai-1,8G0V_YHT,,0.0,,
+1946,Chai-1,7P5T_5YG,0.4999999999999999,0.8,"{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 5, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+1947,Chai-1,7NU0_DCL,0.0,1.0,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1948,Chai-1,6Z0R_Q4H,0.0,1.0,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}","{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}"
+1949,Chai-1,7XRL_FWK,0.1428571428571429,0.9428571428571428,"{'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1950,Chai-1,7LOU_IFM,0.1666666666666667,0.9333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:UDP:VdWContact': 1}"
+1951,Chai-1,7ROU_66I,0.16666666666666674,0.9333333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1952,Chai-1,6XCT_478,0.11111111111111113,0.9555555555555555,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1953,Chai-1,7LT0_ONJ,0.10526315789473695,0.9578947368421052,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+1954,Chai-1,7OLI_8HG,0.058823529411764705,0.9764705882352941,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+1955,Chai-1,7Z1Q_NIO,0.0,1.0,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1956,Chai-1,6YQW_82I,0.3,0.88,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1957,Chai-1,6T88_MWQ,0.4375,0.825,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1958,Chai-1,7PRI_7TI,0.13333333333333341,0.9466666666666667,"{'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1}"
+1959,Chai-1,7OFF_VCB,0.2666666666666668,0.8933333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1960,Chai-1,7DQL_4CL,0.7999999999999999,0.68,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+1961,Chai-1,7O1T_5X8,0.05,0.98,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+1962,Chai-1,7KM8_WPD,0.2631578947368421,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1963,Chai-1,7ZXV_45D,0.3478260869565218,0.8608695652173912,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL::Hydrophobic': 1, 'UNL::VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+1964,Chai-1,7X5N_5M5,0.05263157894736842,0.9789473684210527,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1965,Chai-1,7VQ9_ISY,0.0625,0.975,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+1966,Chai-1,7PJQ_OWH,0.29999999999999993,0.88,"{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+1967,Chai-1,8AQL_PLG,0.31578947368421056,0.8736842105263158,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1968,Chai-1,7VC5_9SF,0.625,0.75,"{'UNL:ASN:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1969,Chai-1,7AFX_R9K,0.3076923076923077,0.8769230769230769,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+1970,Chai-1,7RKW_5TV,0.1428571428571429,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1971,Chai-1,7TYP_KUR,0.2083333333333332,0.9166666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+1972,Chai-1,7L03_F9F,0.16666666666666669,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1973,Chai-1,7P1F_KFN,0.41666666666666663,0.8333333333333334,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1974,Chai-1,7O0N_CDP,0.19047619047619035,0.9238095238095239,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1975,Chai-1,7MYU_ZR7,0.17391304347826086,0.9304347826086956,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+1976,Chai-1,6YSP_PAL,0.4375,0.825,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+1977,Chai-1,7XJN_NSD,,0.0,,
+1978,Chai-1,7R6J_2I7,0.375,0.85,"{'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1979,Chai-1,8HFN_XGC,0.21739130434782605,0.9130434782608696,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1980,Chai-1,7BTT_F8R,0.23076923076923073,0.9076923076923077,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+1981,Chai-1,7MY1_IPE,0.5,0.8,"{'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+1982,Chai-1,8FO5_Y4U,0.4000000000000001,0.84,"{'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}"
+1983,Chai-1,8AUH_L9I,0.7000000000000001,0.72,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+1984,Chai-1,7ECR_SIN,,0.0,,
+1985,Chai-1,6TW5_9M2,0.3999999999999999,0.8400000000000001,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1986,Chai-1,7ELT_TYM,0.17241379310344823,0.9310344827586207,"{'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}"
+1987,Chai-1,7D5C_GV6,0.19999999999999996,0.92,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1988,Chai-1,7W06_ITN,0.14285714285714282,0.9428571428571428,"{'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+1989,Chai-1,6YJA_2BA,0.052631578947368474,0.9789473684210526,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+1990,Chai-1,7P1M_4IU,0.3571428571428573,0.8571428571428571,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+1991,Chai-1,7PGX_FMN,0.09523809523809534,0.9619047619047618,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 4, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+1992,Chai-1,7UAS_MBU,0.2666666666666666,0.8933333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+1993,Chai-1,8GFD_ZHR,0.16666666666666669,0.9333333333333333,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+1994,Chai-1,7CTM_BDP,0.36363636363636354,0.8545454545454546,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CSD:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1}"
+1995,Chai-1,7UQ3_O2U,0.125,0.95,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+1996,Chai-1,7DKT_GLF,0.0,1.0,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+1997,Chai-1,7CNQ_G8X,,0.0,,
+1998,Chai-1,6Z1C_7EY,0.1333333333333333,0.9466666666666667,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}"
+1999,Chai-1,7M3H_YPV,0.26315789473684215,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1}"
+2000,Chai-1,7D6O_MTE,,0.0,,
+2001,Chai-1,7N4W_P4V,0.6,0.76,"{'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2002,Chai-1,6Z2C_Q5E,0.49999999999999994,0.8,"{'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2003,Chai-1,7CIJ_G0C,0.22222222222222227,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2}"
+2004,Chai-1,7USH_82V,0.08333333333333333,0.9666666666666667,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2005,Chai-1,7XG5_PLP,0.06666666666666676,0.9733333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+2006,Chai-1,7PT3_3KK,0.29166666666666674,0.8833333333333333,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2007,Chai-1,7KB1_WBJ,0.21052631578947362,0.9157894736842106,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+2008,Chai-1,7WUX_6OI,0.16666666666666669,0.9333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}"
+2009,Chai-1,7OZ9_NGK,0.375,0.85,"{'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+2010,Chai-1,7N03_ZRP,0.2222222222222223,0.9111111111111111,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2011,Chai-1,7BMI_U4B,0.0625,0.975,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2012,Chai-1,7RZL_NPO,0.2,0.92,"{'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2013,Chai-1,7QHL_D5P,0.11764705882352931,0.9529411764705883,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2014,Chai-1,7N7B_T3F,0.10000000000000003,0.96,"{'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2015,Chai-1,7Q5I_I0F,0.05555555555555555,0.9777777777777777,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+2016,Chai-1,7BKA_4JC,0.7058823529411766,0.7176470588235293,"{'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2017,Chai-1,7NXO_UU8,0.17391304347826092,0.9304347826086956,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2018,Chai-1,6XG5_TOP,0.16666666666666669,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+2019,Chai-1,6XBO_5MC,0.16666666666666669,0.9333333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+2020,Chai-1,8DKO_TFB,0.0,1.0,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2021,Chai-1,7LJN_GTP,0.10526315789473684,0.9578947368421052,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2022,Chai-1,7MOI_HPS,0.08333333333333337,0.9666666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}"
+2023,Chai-1,8G6P_API,1.076923076923077,0.5692307692307692,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+2024,Chai-1,7ULC_56B,0.25,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2025,Chai-1,7RC3_SAH,0.17391304347826084,0.9304347826086956,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2026,Chai-1,7SFO_98L,0.1666666666666665,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+2027,Chai-1,8DP2_UMA,0.3043478260869565,0.8782608695652174,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+2028,Chai-1,7ZZW_KKW,0.27777777777777773,0.888888888888889,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+2029,Chai-1,7XFA_D9J,0.18181818181818174,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+2030,Chai-1,7NP6_UK8,0.3599999999999999,0.8560000000000001,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2031,Chai-1,7F5D_EUO,0.1428571428571428,0.9428571428571428,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2032,Chai-1,6TW7_NZB,0.3571428571428571,0.8571428571428572,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2033,Chai-1,7FHA_ADX,0.15000000000000002,0.94,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 2, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+2034,Chai-1,7ES1_UDP,0.10526315789473684,0.9578947368421052,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2035,Chai-1,7OEO_V9Z,0.0,1.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2036,Chai-1,7DUA_HJ0,0.125,0.95,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2037,Chai-1,7BCP_GCO,0.21428571428571425,0.9142857142857143,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+2038,Chai-1,7P2I_MFU,0.30769230769230765,0.8769230769230769,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}"
+2039,Chai-1,7WDT_NGS,0.1538461538461539,0.9384615384615385,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+2040,Chai-1,8AEM_LVF,0.4,0.84,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2041,Chai-1,7WY1_D0L,0.08333333333333326,0.9666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2042,Chai-1,7KRU_ATP,0.3157894736842105,0.8736842105263158,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}"
+2043,Chai-1,7P4C_5OV,0.0,1.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 2}"
+2044,Chai-1,7MWN_WI5,0.10000000000000003,0.96,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+2045,Chai-1,7ZHP_IQY,0.1600000000000001,0.9359999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2046,Chai-1,7W05_GMP,0.1538461538461539,0.9384615384615385,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+2047,Chai-1,7UJF_R3V,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2048,Chai-1,7LOE_Y84,0.16666666666666666,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+2049,Chai-1,8AIE_M7L,0.375,0.85,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:VdWContact': 5, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+2050,Chai-1,7JY3_VUD,0.27777777777777773,0.888888888888889,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2051,Chai-1,6XM9_V55,0.0714285714285714,0.9714285714285714,"{'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2052,Chai-1,7POM_7VZ,0.23076923076923067,0.9076923076923077,"{'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2053,Chai-1,7M31_TDR,,0.0,,
+2054,Chai-1,8EYE_X4I,0.1428571428571428,0.9428571428571428,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2055,Chai-1,6YRV_PJ8,0.2727272727272728,0.8909090909090909,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2056,Chai-1,7LZD_YHY,0.21052631578947356,0.9157894736842106,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2057,Chai-1,7EPV_FDA,0.1739130434782609,0.9304347826086956,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+2058,Chai-1,7UY4_SMI,0.41666666666666674,0.8333333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2059,Chai-1,7N4N_0BK,0.31578947368421056,0.8736842105263158,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2060,Chai-1,7UMW_NAD,0.040000000000000036,0.984,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2061,Chai-1,7U3J_L6U,0.14285714285714293,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+2062,Chai-1,6Z14_Q4Z,0.4285714285714286,0.8285714285714285,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2063,Chai-1,6ZK5_IMH,0.35294117647058826,0.8588235294117648,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2064,Chai-1,7QGP_DJ8,0.3,0.88,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2065,Chai-1,7L5F_XNG,0.09523809523809518,0.9619047619047619,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2066,Chai-1,7FT9_4MB,0.1333333333333333,0.9466666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+2067,Chai-1,7OP9_06K,,0.0,,
+2068,Chai-1,7JXX_VP7,0.29166666666666663,0.8833333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2069,Chai-1,7CL8_TES,0.35714285714285726,0.8571428571428571,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2070,Chai-1,7TM6_GPJ,0.07692307692307698,0.9692307692307692,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:HBDonor': 2, 'UNL:LYS:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+2071,Chai-1,7WQQ_5Z6,0.3125,0.875,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2072,Chai-1,7WL4_JFU,0.19047619047619047,0.9238095238095239,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2073,Chai-1,7SCW_GSP,0.23076923076923075,0.9076923076923077,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+2074,Chai-1,7L7C_XQ1,0.42857142857142855,0.8285714285714285,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 2}","{'UNL:GLN:Hydrophobic': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+2075,Chai-1,7PUV_84Z,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2076,Chai-1,7KQU_YOF,0.125,0.95,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2077,Chai-1,7Z2O_IAJ,0.30769230769230776,0.8769230769230769,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+2078,Chai-1,7PRM_81I,0.13043478260869562,0.9478260869565217,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2079,Chai-1,8FLV_ZB9,0.18181818181818185,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2080,Chai-1,7NLV_UJE,0.19999999999999996,0.92,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+2081,Chai-1,7T0D_FPP,0.125,0.95,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 5}"
+2082,Chai-1,7MWU_ZPM,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2083,Chai-1,7L00_XCJ,0.7368421052631579,0.7052631578947368,"{'UNL:GLU:Hydrophobic': 3, 'UNL:GLU:VdWContact': 3, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2084,Chai-1,8C5M_MTA,0.19047619047619052,0.9238095238095237,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2085,Chai-1,7Z7F_IF3,0.3333333333333333,0.8666666666666667,"{'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+2086,Chai-1,7TSF_H4B,0.11764705882352942,0.9529411764705882,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+2087,Chai-1,7TUO_KL9,0.16666666666666669,0.9333333333333333,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2088,Chai-1,7ED2_A3P,0.1578947368421052,0.9368421052631579,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2089,Chai-1,7ZL5_IWE,0.4615384615384616,0.8153846153846154,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+2090,Chai-1,8F8E_XJI,0.1363636363636364,0.9454545454545454,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2091,Chai-1,7OZC_G6S,0.35714285714285715,0.8571428571428572,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+2092,Chai-1,7Q2B_M6H,0.1538461538461538,0.9384615384615385,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2093,Chai-1,6VTA_AKN,0.5555555555555556,0.7777777777777778,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 2, 'UNL:ASP:VdWContact': 4, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+2094,Chai-1,7V3N_AKG,0.3333333333333333,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2095,Chai-1,8F4J_PHO,,0.0,,
+2096,Chai-1,7ZOC_T8E,0.07692307692307687,0.9692307692307692,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2097,Chai-1,7WCF_ACP,0.043478260869565216,0.9826086956521739,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+2098,Chai-1,7NUT_GLP,0.125,0.95,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}"
+2099,Chai-1,7E4L_MDN,0.30000000000000004,0.88,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+2100,Chai-1,7TS6_KMI,0.30769230769230765,0.8769230769230769,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2101,Chai-1,7NF3_4LU,0.09999999999999999,0.96,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+2102,Chai-1,8D5D_5DK,0.3,0.88,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2103,Chai-1,7JMV_4NC,0.2941176470588235,0.8823529411764706,"{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2104,Chai-1,7A9E_R4W,0.23076923076923073,0.9076923076923077,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+2105,Chai-1,7TBU_S3P,0.09090909090909088,0.9636363636363636,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+2106,Chai-1,7TB0_UD1,,0.0,,
+2107,Chai-1,7MFP_Z7P,,0.0,,
+2108,Chai-1,6M2B_EZO,0.05555555555555555,0.9777777777777777,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2109,Chai-1,7NPL_UKZ,0.7083333333333333,0.7166666666666667,"{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2110,Chai-1,7KZ9_XN7,0.36363636363636354,0.8545454545454546,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+2111,Chai-1,7QE4_NGA,,0.0,,
+2112,Chai-1,8AP0_PRP,0.1875,0.925,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2113,Chai-1,7V3S_5I9,0.22727272727272738,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 4, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+2114,Chai-1,7C0U_FGO,0.32,0.872,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}"
+2115,Chai-1,7UXS_OJC,0.24000000000000013,0.9039999999999999,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+2116,Chai-1,7X9K_8OG,0.19047619047619052,0.9238095238095237,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2117,Chai-1,8BOM_QU6,0.07999999999999996,0.968,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2118,Chai-1,8BTI_RFO,0.0625,0.975,"{'UNL:ALA:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2119,Chai-1,7RWS_4UR,0.4375,0.825,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2120,Chai-1,6YQV_8K2,0.1428571428571429,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2121,Chai-1,7PK0_BYC,0.11999999999999995,0.9520000000000001,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2122,Chai-1,5SIS_JSM,0.15789473684210525,0.9368421052631579,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2123,Chai-1,7NSW_HC4,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2124,Chai-1,7F8T_FAD,0.3214285714285713,0.8714285714285714,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2125,Chai-1,5SD5_HWI,0.31578947368421045,0.8736842105263158,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2126,Chai-1,7CUO_PHB,0.125,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2127,Chai-1,7R3D_APR,0.22222222222222224,0.9111111111111111,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+2128,Chai-1,7WJB_BGC,0.2727272727272727,0.8909090909090909,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+2129,Chai-1,7A1P_QW2,0.1578947368421053,0.9368421052631579,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+2130,Chai-1,6ZPB_3D1,0.38095238095238093,0.8476190476190476,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2131,Chai-1,7UTW_NAI,0.11999999999999997,0.952,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+2132,Chai-1,7WUY_76N,0.4782608695652174,0.808695652173913,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2133,Chai-1,8A2D_KXY,0.2592592592592593,0.8962962962962963,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+2134,Chai-1,7NR8_UOE,0.15999999999999998,0.936,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1}"
+2135,Chai-1,7KC5_BJZ,0.6,0.76,"{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2136,Chai-1,7QPP_VDX,0.10526315789473684,0.9578947368421052,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2137,Chai-1,7VKZ_NOJ,,0.0,,
+2138,Chai-1,7F51_BA7,0.19354838709677424,0.9225806451612903,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}"
+2139,Chai-1,7PL1_SFG,0.08695652173913043,0.9652173913043478,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+2140,Chai-1,7VB8_STL,0.21428571428571422,0.9142857142857144,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2141,Chai-1,8FAV_4Y5,0.18181818181818188,0.9272727272727272,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2142,Chai-1,7CD9_FVR,0.7058823529411764,0.7176470588235294,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 4, 'UNL:THR:VdWContact': 4, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}"
+2143,Chai-1,7N7H_CTP,0.1363636363636364,0.9454545454545454,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2144,Chai-1,7ODY_DGI,0.09090909090909091,0.9636363636363636,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2}"
+2145,Chai-1,8CSD_C5P,0.375,0.85,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2146,Chai-1,7OFK_VCH,0.1428571428571429,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2147,Chai-1,7SDD_4IP,0.16666666666666663,0.9333333333333333,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 4, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+2148,Chai-1,7OPG_06N,0.14285714285714293,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+2149,Chai-1,7ZTL_BCN,0.0,1.0,"{'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+2150,Chai-1,7SIU_9ID,0.4347826086956521,0.8260869565217391,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2151,Chai-1,7LCU_XTA,0.49999999999999994,0.8,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2152,Chai-1,7NGW_UAW,0.10526315789473678,0.9578947368421052,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2153,Chai-1,7VYJ_CA0,0.11764705882352942,0.9529411764705882,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2154,Chai-1,7QHG_T3B,0.27586206896551724,0.8896551724137931,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+2155,Chai-1,8HO0_3ZI,0.3846153846153847,0.8461538461538461,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2156,Boltz-1-Single-Seq,8AAU_LH0,0.375,0.85,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2157,Boltz-1-Single-Seq,7JHQ_VAJ,0.30769230769230765,0.8769230769230769,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2158,Boltz-1-Single-Seq,6ZCY_QF8,0.13043478260869565,0.9478260869565217,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2159,Boltz-1-Single-Seq,7UAW_MF6,0.375,0.85,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+2160,Boltz-1-Single-Seq,6YMS_OZH,0.23809523809523814,0.9047619047619048,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2161,Boltz-1-Single-Seq,7UJ5_DGL,0.1578947368421053,0.9368421052631579,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2162,Boltz-1-Single-Seq,8EX2_Q2Q,,0.0,,
+2163,Boltz-1-Single-Seq,7R9N_F97,0.4117647058823529,0.8352941176470589,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2164,Boltz-1-Single-Seq,7UYB_OK0,0.06666666666666665,0.9733333333333334,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+2165,Boltz-1-Single-Seq,7U0U_FK5,0.25806451612903225,0.896774193548387,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2166,Boltz-1-Single-Seq,7ZU2_DHT,0.08333333333333333,0.9666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2167,Boltz-1-Single-Seq,6XHT_V2V,0.4705882352941176,0.8117647058823529,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+2168,Boltz-1-Single-Seq,7OSO_0V1,0.25000000000000006,0.9,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+2169,Boltz-1-Single-Seq,8D19_GSH,0.1764705882352941,0.9294117647058824,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+2170,Boltz-1-Single-Seq,7MGT_ZD4,0.045454545454545456,0.9818181818181818,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2171,Boltz-1-Single-Seq,8C3N_ADP,0.19999999999999998,0.92,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+2172,Boltz-1-Single-Seq,6YYO_Q1K,,0.0,,
+2173,Boltz-1-Single-Seq,8A1H_DLZ,,0.0,,
+2174,Boltz-1-Single-Seq,7XQZ_FPF,0.19047619047619052,0.9238095238095237,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2175,Boltz-1-Single-Seq,7RH3_59O,0.09090909090909094,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+2176,Boltz-1-Single-Seq,7OMX_CNA,0.19999999999999993,0.92,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2177,Boltz-1-Single-Seq,7LMO_NYO,0.45000000000000007,0.82,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2178,Boltz-1-Single-Seq,7VBU_6I4,0.0714285714285714,0.9714285714285714,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2179,Boltz-1-Single-Seq,7TXK_LW8,0.09999999999999998,0.96,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2180,Boltz-1-Single-Seq,7T1D_E7K,0.6363636363636364,0.7454545454545455,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:PHE:Hydrophobic': 7, 'UNL:PHE:VdWContact': 6, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 7, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2181,Boltz-1-Single-Seq,7R59_I5F,0.1,0.96,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2182,Boltz-1-Single-Seq,7ZCC_OGA,,0.0,,
+2183,Boltz-1-Single-Seq,7V43_C4O,,0.0,,
+2184,Boltz-1-Single-Seq,7BNH_BEZ,0.6363636363636362,0.7454545454545455,"{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+2185,Boltz-1-Single-Seq,6WTN_RXT,0.05263157894736842,0.9789473684210527,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2186,Boltz-1-Single-Seq,7QFM_AY3,0.31578947368421045,0.8736842105263158,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2187,Boltz-1-Single-Seq,7MSR_DCA,0.08695652173913038,0.9652173913043478,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2188,Boltz-1-Single-Seq,5SAK_ZRY,,0.0,,
+2189,Boltz-1-Single-Seq,7QTA_URI,,0.0,,
+2190,Boltz-1-Single-Seq,7RSV_7IQ,0.5,0.8,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+2191,Boltz-1-Single-Seq,8DSC_NCA,0.33333333333333337,0.8666666666666667,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+2192,Boltz-1-Single-Seq,7AKL_RK5,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+2193,Boltz-1-Single-Seq,7XBV_APC,0.15789473684210525,0.9368421052631579,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2194,Boltz-1-Single-Seq,7CNS_PMV,0.047619047619047616,0.9809523809523809,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2195,Boltz-1-Single-Seq,7ZDY_6MJ,0.25,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+2196,Boltz-1-Single-Seq,6Z4N_Q7B,0.14999999999999997,0.9400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+2197,Boltz-1-Single-Seq,7NFB_GEN,,0.0,,
+2198,Boltz-1-Single-Seq,7R7R_AWJ,0.11111111111111116,0.9555555555555555,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2199,Boltz-1-Single-Seq,7V14_ORU,0.1333333333333333,0.9466666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2200,Boltz-1-Single-Seq,6YR2_T1C,0.2857142857142857,0.8857142857142857,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2201,Boltz-1-Single-Seq,7JG0_GAR,0.27272727272727276,0.8909090909090909,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:V:VdWContact': 1}"
+2202,Boltz-1-Single-Seq,7EBG_J0L,0.36363636363636365,0.8545454545454545,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2203,Boltz-1-Single-Seq,8AY3_OE3,0.125,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2204,Boltz-1-Single-Seq,7M6K_YRJ,0.04999999999999999,0.98,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2205,Boltz-1-Single-Seq,6YT6_PKE,0.19047619047619047,0.9238095238095239,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2206,Boltz-1-Single-Seq,7Q27_8KC,0.14999999999999997,0.9400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2207,Boltz-1-Single-Seq,8DHG_T78,0.2857142857142857,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2208,Boltz-1-Single-Seq,8EXL_799,0.1739130434782608,0.9304347826086957,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+2209,Boltz-1-Single-Seq,7FB7_8NF,0.26666666666666666,0.8933333333333333,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+2210,Boltz-1-Single-Seq,7THI_PGA,0.1538461538461539,0.9384615384615385,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+2211,Boltz-1-Single-Seq,6ZAE_ACV,0.20000000000000007,0.9199999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2212,Boltz-1-Single-Seq,7MGY_ZD1,0.20000000000000012,0.9199999999999999,"{'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2213,Boltz-1-Single-Seq,7XPO_UPG,0.3333333333333334,0.8666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2214,Boltz-1-Single-Seq,7SUC_COM,,0.0,,
+2215,Boltz-1-Single-Seq,7BJJ_TVW,0.1111111111111111,0.9555555555555556,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2216,Boltz-1-Single-Seq,7K0V_VQP,0.14285714285714285,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2217,Boltz-1-Single-Seq,7TE8_P0T,0.45833333333333326,0.8166666666666667,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2218,Boltz-1-Single-Seq,7QF4_RBF,0.0,1.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+2219,Boltz-1-Single-Seq,7UJ4_OQ4,0.24999999999999997,0.9,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+2220,Boltz-1-Single-Seq,7A9H_TPP,0.18518518518518529,0.9259259259259259,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+2221,Boltz-1-Single-Seq,7LEV_0JO,0.19047619047619058,0.9238095238095237,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2}"
+2222,Boltz-1-Single-Seq,7N6F_0I1,,0.0,,
+2223,Boltz-1-Single-Seq,8EAB_VN2,0.2857142857142858,0.8857142857142857,"{'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2224,Boltz-1-Single-Seq,6ZC3_JOR,0.05555555555555555,0.9777777777777777,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2225,Boltz-1-Single-Seq,7Q25_8J9,,0.0,,
+2226,Boltz-1-Single-Seq,7C3U_AZG,0.25,0.9,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2}"
+2227,Boltz-1-Single-Seq,7ROR_69X,0.10344827586206888,0.9586206896551724,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2228,Boltz-1-Single-Seq,7MMH_ZJY,0.10714285714285711,0.9571428571428572,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2229,Boltz-1-Single-Seq,7TH4_FFO,0.3,0.88,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2230,Boltz-1-Single-Seq,8D39_QDB,,0.0,,
+2231,Boltz-1-Single-Seq,7YZU_DO7,0.33333333333333326,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+2232,Boltz-1-Single-Seq,5SB2_1K2,0.2592592592592592,0.8962962962962964,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2233,Boltz-1-Single-Seq,6M73_FNR,0.0357142857142857,0.9857142857142858,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2234,Boltz-1-Single-Seq,8B8H_OJQ,0.15384615384615383,0.9384615384615385,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+2235,Boltz-1-Single-Seq,7TOM_5AD,0.27272727272727276,0.8909090909090909,"{'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2236,Boltz-1-Single-Seq,7VWF_K55,0.25925925925925924,0.8962962962962963,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+2237,Boltz-1-Single-Seq,7XI7_4RI,0.25000000000000006,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2238,Boltz-1-Single-Seq,7AN5_RDH,0.12000000000000008,0.952,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+2239,Boltz-1-Single-Seq,7B2C_TP7,,0.0,,
+2240,Boltz-1-Single-Seq,7B94_ANP,0.2272727272727273,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2241,Boltz-1-Single-Seq,7NF0_BYN,0.09677419354838704,0.9612903225806452,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}"
+2242,Boltz-1-Single-Seq,7WKL_CAQ,0.08333333333333333,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2243,Boltz-1-Single-Seq,7WPW_F15,0.17647058823529416,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2244,Boltz-1-Single-Seq,8SLG_G5A,0.2941176470588236,0.8823529411764706,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+2245,Boltz-1-Single-Seq,7RNI_60I,,0.0,,
+2246,Boltz-1-Single-Seq,7SZA_DUI,0.09999999999999998,0.96,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2247,Boltz-1-Single-Seq,7PIH_7QW,0.11111111111111113,0.9555555555555555,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2248,Boltz-1-Single-Seq,7T3E_SLB,0.0,1.0,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+2249,Boltz-1-Single-Seq,7FRX_O88,,0.0,,
+2250,Boltz-1-Single-Seq,8CNH_V6U,0.4444444444444444,0.8222222222222222,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+2251,Boltz-1-Single-Seq,7C8Q_DSG,,0.0,,
+2252,Boltz-1-Single-Seq,7ZF0_DHR,0.36363636363636354,0.8545454545454546,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3}"
+2253,Boltz-1-Single-Seq,8G0V_YHT,,0.0,,
+2254,Boltz-1-Single-Seq,7P5T_5YG,,0.0,,
+2255,Boltz-1-Single-Seq,7NU0_DCL,0.08333333333333337,0.9666666666666667,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2256,Boltz-1-Single-Seq,6Z0R_Q4H,0.2727272727272727,0.8909090909090909,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}","{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}"
+2257,Boltz-1-Single-Seq,7XRL_FWK,,0.0,,
+2258,Boltz-1-Single-Seq,7LOU_IFM,0.08333333333333334,0.9666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:UDP:VdWContact': 1}"
+2259,Boltz-1-Single-Seq,7ROU_66I,0.125,0.95,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2260,Boltz-1-Single-Seq,6XCT_478,0.2500000000000001,0.8999999999999999,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2261,Boltz-1-Single-Seq,7LT0_ONJ,0.21052631578947378,0.9157894736842105,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2262,Boltz-1-Single-Seq,7OLI_8HG,0.0,1.0,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+2263,Boltz-1-Single-Seq,7Z1Q_NIO,0.09999999999999998,0.96,"{'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2264,Boltz-1-Single-Seq,6YQW_82I,0.1,0.96,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2265,Boltz-1-Single-Seq,6T88_MWQ,0.35714285714285715,0.8571428571428572,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2266,Boltz-1-Single-Seq,7PRI_7TI,0.06666666666666671,0.9733333333333333,"{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1}"
+2267,Boltz-1-Single-Seq,7OFF_VCB,0.2,0.92,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2268,Boltz-1-Single-Seq,7DQL_4CL,0.3333333333333333,0.8666666666666667,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+2269,Boltz-1-Single-Seq,7O1T_5X8,0.05,0.98,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2270,Boltz-1-Single-Seq,7KM8_WPD,0.15000000000000008,0.94,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2271,Boltz-1-Single-Seq,7ZXV_45D,0.19999999999999996,0.92,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL::Hydrophobic': 1, 'UNL::VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2272,Boltz-1-Single-Seq,7X5N_5M5,0.21739130434782608,0.9130434782608696,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2273,Boltz-1-Single-Seq,7VQ9_ISY,0.3125,0.875,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+2274,Boltz-1-Single-Seq,7PJQ_OWH,0.09090909090909083,0.9636363636363636,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2275,Boltz-1-Single-Seq,8AQL_PLG,,0.0,,
+2276,Boltz-1-Single-Seq,7VC5_9SF,0.3529411764705882,0.8588235294117648,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2277,Boltz-1-Single-Seq,7AFX_R9K,0.14285714285714288,0.9428571428571428,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+2278,Boltz-1-Single-Seq,7RKW_5TV,,0.0,,
+2279,Boltz-1-Single-Seq,7TYP_KUR,0.29166666666666663,0.8833333333333333,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2280,Boltz-1-Single-Seq,7L03_F9F,0.05555555555555555,0.9777777777777777,"{'UNL:ALA:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2281,Boltz-1-Single-Seq,7P1F_KFN,0.2142857142857143,0.9142857142857143,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2282,Boltz-1-Single-Seq,7O0N_CDP,0.09523809523809523,0.9619047619047619,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2283,Boltz-1-Single-Seq,7MYU_ZR7,0.0,1.0,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2284,Boltz-1-Single-Seq,6YSP_PAL,0.4375,0.825,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+2285,Boltz-1-Single-Seq,7XJN_NSD,0.5833333333333335,0.7666666666666666,"{'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 5, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2286,Boltz-1-Single-Seq,7R6J_2I7,,0.0,,
+2287,Boltz-1-Single-Seq,8HFN_XGC,0.1739130434782608,0.9304347826086957,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2288,Boltz-1-Single-Seq,7BTT_F8R,0.2857142857142857,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2289,Boltz-1-Single-Seq,7MY1_IPE,0.5000000000000001,0.7999999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+2290,Boltz-1-Single-Seq,8FO5_Y4U,0.5454545454545454,0.7818181818181819,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 5}","{'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}"
+2291,Boltz-1-Single-Seq,8AUH_L9I,0.14285714285714282,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+2292,Boltz-1-Single-Seq,7ECR_SIN,,0.0,,
+2293,Boltz-1-Single-Seq,6TW5_9M2,,0.0,,
+2294,Boltz-1-Single-Seq,7ELT_TYM,0.10714285714285722,0.9571428571428571,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}"
+2295,Boltz-1-Single-Seq,7D5C_GV6,0.1111111111111111,0.9555555555555556,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2296,Boltz-1-Single-Seq,7W06_ITN,0.2666666666666667,0.8933333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+2297,Boltz-1-Single-Seq,6YJA_2BA,0.23809523809523808,0.9047619047619048,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2298,Boltz-1-Single-Seq,7P1M_4IU,0.0,1.0,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+2299,Boltz-1-Single-Seq,7PGX_FMN,0.09090909090909091,0.9636363636363636,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+2300,Boltz-1-Single-Seq,7UAS_MBU,0.23529411764705888,0.9058823529411765,"{'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+2301,Boltz-1-Single-Seq,8GFD_ZHR,0.31578947368421045,0.8736842105263158,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2302,Boltz-1-Single-Seq,7CTM_BDP,0.07692307692307698,0.9692307692307692,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CSD:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1}"
+2303,Boltz-1-Single-Seq,7UQ3_O2U,0.07142857142857142,0.9714285714285714,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2304,Boltz-1-Single-Seq,7DKT_GLF,0.08333333333333337,0.9666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+2305,Boltz-1-Single-Seq,7CNQ_G8X,,0.0,,
+2306,Boltz-1-Single-Seq,6Z1C_7EY,0.1333333333333333,0.9466666666666667,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}"
+2307,Boltz-1-Single-Seq,7M3H_YPV,0.23529411764705885,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1}"
+2308,Boltz-1-Single-Seq,7D6O_MTE,,0.0,,
+2309,Boltz-1-Single-Seq,7N4W_P4V,0.1875,0.925,"{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2310,Boltz-1-Single-Seq,6Z2C_Q5E,0.5,0.8,"{'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2311,Boltz-1-Single-Seq,7CIJ_G0C,0.3684210526315789,0.8526315789473684,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2}"
+2312,Boltz-1-Single-Seq,7USH_82V,0.16666666666666666,0.9333333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2313,Boltz-1-Single-Seq,7XG5_PLP,0.20000000000000007,0.9199999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+2314,Boltz-1-Single-Seq,7PT3_3KK,0.22727272727272732,0.9090909090909091,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2315,Boltz-1-Single-Seq,7KB1_WBJ,,0.0,,
+2316,Boltz-1-Single-Seq,7WUX_6OI,,0.0,,
+2317,Boltz-1-Single-Seq,7OZ9_NGK,0.375,0.85,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+2318,Boltz-1-Single-Seq,7N03_ZRP,0.1666666666666667,0.9333333333333333,"{'UNL:ASN:HBDonor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2319,Boltz-1-Single-Seq,7BMI_U4B,0.0,1.0,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2320,Boltz-1-Single-Seq,7RZL_NPO,0.2,0.92,"{'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2321,Boltz-1-Single-Seq,7QHL_D5P,0.2000000000000001,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2322,Boltz-1-Single-Seq,7N7B_T3F,0.1363636363636364,0.9454545454545454,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2323,Boltz-1-Single-Seq,7Q5I_I0F,0.15789473684210537,0.9368421052631578,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+2324,Boltz-1-Single-Seq,7BKA_4JC,0.0625,0.975,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2325,Boltz-1-Single-Seq,7NXO_UU8,0.26086956521739124,0.8956521739130435,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2326,Boltz-1-Single-Seq,6XG5_TOP,0.07692307692307687,0.9692307692307692,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+2327,Boltz-1-Single-Seq,6XBO_5MC,0.10526315789473684,0.9578947368421052,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+2328,Boltz-1-Single-Seq,8DKO_TFB,0.125,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2329,Boltz-1-Single-Seq,7LJN_GTP,,0.0,,
+2330,Boltz-1-Single-Seq,7MOI_HPS,0.27272727272727276,0.8909090909090909,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}"
+2331,Boltz-1-Single-Seq,8G6P_API,0.10000000000000009,0.96,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 2, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+2332,Boltz-1-Single-Seq,7ULC_56B,0.14285714285714296,0.9428571428571428,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2333,Boltz-1-Single-Seq,7RC3_SAH,0.19999999999999998,0.92,"{'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2334,Boltz-1-Single-Seq,7SFO_98L,0.2777777777777778,0.8888888888888888,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+2335,Boltz-1-Single-Seq,8DP2_UMA,0.040000000000000036,0.984,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+2336,Boltz-1-Single-Seq,7ZZW_KKW,,0.0,,
+2337,Boltz-1-Single-Seq,7XFA_D9J,0.33333333333333326,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+2338,Boltz-1-Single-Seq,7NP6_UK8,0.29032258064516137,0.8838709677419354,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2339,Boltz-1-Single-Seq,7F5D_EUO,0.2142857142857143,0.9142857142857143,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2340,Boltz-1-Single-Seq,6TW7_NZB,0.1333333333333333,0.9466666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2341,Boltz-1-Single-Seq,7FHA_ADX,0.09523809523809518,0.9619047619047619,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+2342,Boltz-1-Single-Seq,7ES1_UDP,0.052631578947368474,0.9789473684210526,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2343,Boltz-1-Single-Seq,7OEO_V9Z,0.2222222222222222,0.9111111111111111,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2344,Boltz-1-Single-Seq,7DUA_HJ0,0.2631578947368421,0.8947368421052632,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2345,Boltz-1-Single-Seq,7BCP_GCO,0.1333333333333333,0.9466666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+2346,Boltz-1-Single-Seq,7P2I_MFU,0.30769230769230765,0.8769230769230769,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}"
+2347,Boltz-1-Single-Seq,7WDT_NGS,0.4,0.84,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+2348,Boltz-1-Single-Seq,8AEM_LVF,0.4000000000000001,0.84,"{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2349,Boltz-1-Single-Seq,7WY1_D0L,,0.0,,
+2350,Boltz-1-Single-Seq,7KRU_ATP,0.380952380952381,0.8476190476190476,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 7, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}"
+2351,Boltz-1-Single-Seq,7P4C_5OV,0.21428571428571433,0.9142857142857143,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 2}"
+2352,Boltz-1-Single-Seq,7MWN_WI5,0.1363636363636364,0.9454545454545454,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+2353,Boltz-1-Single-Seq,7ZHP_IQY,0.18181818181818185,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2354,Boltz-1-Single-Seq,7W05_GMP,0.07142857142857151,0.9714285714285714,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+2355,Boltz-1-Single-Seq,7UJF_R3V,0.25,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2356,Boltz-1-Single-Seq,7LOE_Y84,0.16666666666666666,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+2357,Boltz-1-Single-Seq,8AIE_M7L,0.3571428571428572,0.8571428571428571,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 5, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+2358,Boltz-1-Single-Seq,7JY3_VUD,,0.0,,
+2359,Boltz-1-Single-Seq,6XM9_V55,0.5,0.8,"{'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2360,Boltz-1-Single-Seq,7POM_7VZ,0.23529411764705885,0.9058823529411765,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2361,Boltz-1-Single-Seq,7M31_TDR,,0.0,,
+2362,Boltz-1-Single-Seq,8EYE_X4I,0.24999999999999997,0.9,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2363,Boltz-1-Single-Seq,6YRV_PJ8,0.1363636363636363,0.9454545454545454,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2364,Boltz-1-Single-Seq,7LZD_YHY,0.5333333333333333,0.7866666666666666,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2365,Boltz-1-Single-Seq,7EPV_FDA,0.24000000000000002,0.904,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+2366,Boltz-1-Single-Seq,7UY4_SMI,0.26666666666666666,0.8933333333333333,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2367,Boltz-1-Single-Seq,7N4N_0BK,0.2777777777777778,0.8888888888888888,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2368,Boltz-1-Single-Seq,7UMW_NAD,0.11538461538461536,0.9538461538461539,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2369,Boltz-1-Single-Seq,7U3J_L6U,0.153846153846154,0.9384615384615385,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+2370,Boltz-1-Single-Seq,6Z14_Q4Z,0.21428571428571433,0.9142857142857143,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2371,Boltz-1-Single-Seq,6ZK5_IMH,0.47368421052631576,0.8105263157894738,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2372,Boltz-1-Single-Seq,7QGP_DJ8,0.1904761904761904,0.9238095238095239,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2373,Boltz-1-Single-Seq,7L5F_XNG,0.20833333333333331,0.9166666666666666,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2374,Boltz-1-Single-Seq,7FT9_4MB,0.14285714285714285,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+2375,Boltz-1-Single-Seq,7OP9_06K,,0.0,,
+2376,Boltz-1-Single-Seq,7JXX_VP7,0.045454545454545456,0.9818181818181818,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2377,Boltz-1-Single-Seq,7CL8_TES,,0.0,,
+2378,Boltz-1-Single-Seq,7TM6_GPJ,0.20000000000000007,0.9199999999999999,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+2379,Boltz-1-Single-Seq,7WQQ_5Z6,0.23529411764705885,0.9058823529411765,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2380,Boltz-1-Single-Seq,7WL4_JFU,0.10526315789473684,0.9578947368421052,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2381,Boltz-1-Single-Seq,7SCW_GSP,0.19230769230769226,0.9230769230769231,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+2382,Boltz-1-Single-Seq,7L7C_XQ1,0.5714285714285715,0.7714285714285714,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+2383,Boltz-1-Single-Seq,7PUV_84Z,0.125,0.95,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2384,Boltz-1-Single-Seq,7KQU_YOF,,0.0,,
+2385,Boltz-1-Single-Seq,7Z2O_IAJ,0.21428571428571427,0.9142857142857143,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+2386,Boltz-1-Single-Seq,7PRM_81I,0.1304347826086957,0.9478260869565217,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2387,Boltz-1-Single-Seq,8FLV_ZB9,0.13043478260869565,0.9478260869565217,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2388,Boltz-1-Single-Seq,7NLV_UJE,0.06666666666666665,0.9733333333333334,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+2389,Boltz-1-Single-Seq,7T0D_FPP,,0.0,,
+2390,Boltz-1-Single-Seq,7MWU_ZPM,0.22222222222222227,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2391,Boltz-1-Single-Seq,7L00_XCJ,0.2173913043478261,0.9130434782608695,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2392,Boltz-1-Single-Seq,8C5M_MTA,,0.0,,
+2393,Boltz-1-Single-Seq,7Z7F_IF3,0.14285714285714282,0.9428571428571428,"{'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+2394,Boltz-1-Single-Seq,7TSF_H4B,,0.0,,
+2395,Boltz-1-Single-Seq,7TUO_KL9,0.4482758620689654,0.8206896551724139,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2396,Boltz-1-Single-Seq,7ED2_A3P,0.22222222222222224,0.9111111111111111,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2397,Boltz-1-Single-Seq,7ZL5_IWE,0.5,0.8,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+2398,Boltz-1-Single-Seq,8F8E_XJI,0.44,0.8240000000000001,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2399,Boltz-1-Single-Seq,7OZC_G6S,0.19999999999999998,0.92,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+2400,Boltz-1-Single-Seq,7Q2B_M6H,0.07692307692307687,0.9692307692307692,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2401,Boltz-1-Single-Seq,6VTA_AKN,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+2402,Boltz-1-Single-Seq,7V3N_AKG,0.375,0.85,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2403,Boltz-1-Single-Seq,8F4J_PHO,,0.0,,
+2404,Boltz-1-Single-Seq,7ZOC_T8E,0.28571428571428564,0.8857142857142858,"{'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2405,Boltz-1-Single-Seq,7WCF_ACP,0.08000000000000002,0.968,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 4, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+2406,Boltz-1-Single-Seq,7NUT_GLP,0.21428571428571425,0.9142857142857143,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}"
+2407,Boltz-1-Single-Seq,7E4L_MDN,0.5000000000000001,0.7999999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+2408,Boltz-1-Single-Seq,7TS6_KMI,,0.0,,
+2409,Boltz-1-Single-Seq,7NF3_4LU,0.10344827586206892,0.9586206896551724,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+2410,Boltz-1-Single-Seq,8D5D_5DK,0.1739130434782608,0.9304347826086957,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2411,Boltz-1-Single-Seq,7JMV_4NC,0.11764705882352933,0.9529411764705883,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2412,Boltz-1-Single-Seq,7A9E_R4W,0.6153846153846153,0.7538461538461538,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+2413,Boltz-1-Single-Seq,7TBU_S3P,0.3333333333333333,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 5, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+2414,Boltz-1-Single-Seq,7TB0_UD1,,0.0,,
+2415,Boltz-1-Single-Seq,7MFP_Z7P,0.38235294117647045,0.8470588235294119,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 5, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+2416,Boltz-1-Single-Seq,6M2B_EZO,0.1578947368421053,0.9368421052631579,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2417,Boltz-1-Single-Seq,7NPL_UKZ,0.52,0.792,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2418,Boltz-1-Single-Seq,7KZ9_XN7,0.24999999999999994,0.9,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+2419,Boltz-1-Single-Seq,7QE4_NGA,,0.0,,
+2420,Boltz-1-Single-Seq,8AP0_PRP,0.17647058823529416,0.9294117647058824,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2421,Boltz-1-Single-Seq,7V3S_5I9,0.21739130434782616,0.9130434782608695,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+2422,Boltz-1-Single-Seq,7C0U_FGO,0.1428571428571429,0.9428571428571428,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}"
+2423,Boltz-1-Single-Seq,7UXS_OJC,0.19047619047619052,0.9238095238095237,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+2424,Boltz-1-Single-Seq,7X9K_8OG,0.05,0.98,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2425,Boltz-1-Single-Seq,8BOM_QU6,0.07999999999999996,0.968,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2426,Boltz-1-Single-Seq,8BTI_RFO,0.13333333333333333,0.9466666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2427,Boltz-1-Single-Seq,7RWS_4UR,0.4375,0.825,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2428,Boltz-1-Single-Seq,6YQV_8K2,0.4444444444444445,0.8222222222222222,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2429,Boltz-1-Single-Seq,7PK0_BYC,0.039999999999999994,0.984,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2430,Boltz-1-Single-Seq,5SIS_JSM,0.1578947368421052,0.9368421052631579,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2431,Boltz-1-Single-Seq,7NSW_HC4,0.043478260869565216,0.9826086956521739,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2432,Boltz-1-Single-Seq,7F8T_FAD,0.4285714285714285,0.8285714285714286,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2433,Boltz-1-Single-Seq,5SD5_HWI,0.23529411764705876,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2434,Boltz-1-Single-Seq,7CUO_PHB,0.1578947368421052,0.9368421052631579,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2435,Boltz-1-Single-Seq,7R3D_APR,0.22222222222222224,0.9111111111111111,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+2436,Boltz-1-Single-Seq,7WJB_BGC,0.09090909090909088,0.9636363636363636,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+2437,Boltz-1-Single-Seq,7A1P_QW2,0.15789473684210525,0.9368421052631579,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+2438,Boltz-1-Single-Seq,6ZPB_3D1,0.3125,0.875,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2439,Boltz-1-Single-Seq,7UTW_NAI,0.045454545454545414,0.9818181818181818,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+2440,Boltz-1-Single-Seq,7WUY_76N,,0.0,,
+2441,Boltz-1-Single-Seq,8A2D_KXY,0.2413793103448276,0.903448275862069,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+2442,Boltz-1-Single-Seq,7NR8_UOE,,0.0,,
+2443,Boltz-1-Single-Seq,7KC5_BJZ,0.7142857142857142,0.7142857142857143,"{'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2444,Boltz-1-Single-Seq,7QPP_VDX,0.04999999999999993,0.98,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2445,Boltz-1-Single-Seq,7VKZ_NOJ,0.3846153846153846,0.8461538461538461,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+2446,Boltz-1-Single-Seq,7F51_BA7,0.19354838709677424,0.9225806451612903,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}"
+2447,Boltz-1-Single-Seq,7PL1_SFG,0.09090909090909086,0.9636363636363636,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+2448,Boltz-1-Single-Seq,7VB8_STL,,0.0,,
+2449,Boltz-1-Single-Seq,8FAV_4Y5,0.22222222222222227,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 4, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2450,Boltz-1-Single-Seq,7CD9_FVR,0.5,0.8,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 4, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 5, 'UNL:TYR:VdWContact': 5}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}"
+2451,Boltz-1-Single-Seq,7N7H_CTP,0.13043478260869565,0.9478260869565217,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2452,Boltz-1-Single-Seq,7ODY_DGI,0.28571428571428564,0.8857142857142858,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2}"
+2453,Boltz-1-Single-Seq,8CSD_C5P,0.25,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2454,Boltz-1-Single-Seq,7OFK_VCH,0.14285714285714285,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2455,Boltz-1-Single-Seq,7SDD_4IP,0.3333333333333332,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+2456,Boltz-1-Single-Seq,7OPG_06N,0.375,0.85,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+2457,Boltz-1-Single-Seq,7ZTL_BCN,0.5833333333333335,0.7666666666666666,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:HIS:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+2458,Boltz-1-Single-Seq,7SIU_9ID,0.3478260869565218,0.8608695652173912,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2459,Boltz-1-Single-Seq,7LCU_XTA,0.2380952380952382,0.9047619047619048,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2460,Boltz-1-Single-Seq,7NGW_UAW,0.1,0.96,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2461,Boltz-1-Single-Seq,7VYJ_CA0,,0.0,,
+2462,Boltz-1-Single-Seq,7QHG_T3B,0.2413793103448274,0.903448275862069,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+2463,Boltz-1-Single-Seq,8HO0_3ZI,,0.0,,
+2464,Boltz-1,8AAU_LH0,0.3125,0.875,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2465,Boltz-1,7JHQ_VAJ,0.4,0.84,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2466,Boltz-1,6ZCY_QF8,0.17391304347826092,0.9304347826086956,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2467,Boltz-1,7UAW_MF6,0.375,0.85,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+2468,Boltz-1,6YMS_OZH,0.1428571428571429,0.9428571428571428,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2469,Boltz-1,7UJ5_DGL,0.21052631578947373,0.9157894736842105,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2470,Boltz-1,8EX2_Q2Q,,0.0,,
+2471,Boltz-1,7R9N_F97,0.4375,0.825,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2472,Boltz-1,7UYB_OK0,0.2,0.92,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+2473,Boltz-1,7U0U_FK5,0.33333333333333337,0.8666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2474,Boltz-1,7ZU2_DHT,0.15384615384615374,0.9384615384615385,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2475,Boltz-1,6XHT_V2V,0.22222222222222227,0.9111111111111111,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+2476,Boltz-1,7OSO_0V1,0.2727272727272727,0.8909090909090909,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+2477,Boltz-1,8D19_GSH,0.5,0.8,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+2478,Boltz-1,7MGT_ZD4,0.16666666666666674,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2479,Boltz-1,8C3N_ADP,0.1578947368421053,0.9368421052631579,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+2480,Boltz-1,6YYO_Q1K,,0.0,,
+2481,Boltz-1,8A1H_DLZ,,0.0,,
+2482,Boltz-1,7XQZ_FPF,0.1304347826086957,0.9478260869565217,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2483,Boltz-1,7RH3_59O,0.18181818181818185,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+2484,Boltz-1,7OMX_CNA,0.30434782608695654,0.8782608695652174,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2485,Boltz-1,7LMO_NYO,0.619047619047619,0.7523809523809524,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2486,Boltz-1,7VBU_6I4,0.0714285714285714,0.9714285714285714,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2487,Boltz-1,7TXK_LW8,0.15789473684210525,0.9368421052631579,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2488,Boltz-1,7T1D_E7K,0.4210526315789473,0.8315789473684211,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 8, 'UNL:PHE:VdWContact': 7, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 7, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2489,Boltz-1,7R59_I5F,0.1,0.96,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2490,Boltz-1,7ZCC_OGA,,0.0,,
+2491,Boltz-1,7V43_C4O,,0.0,,
+2492,Boltz-1,7BNH_BEZ,1.1428571428571428,0.5428571428571429,{},"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+2493,Boltz-1,6WTN_RXT,0.11764705882352944,0.9529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2494,Boltz-1,7QFM_AY3,0.3684210526315789,0.8526315789473684,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2495,Boltz-1,7MSR_DCA,0.13043478260869557,0.9478260869565218,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2496,Boltz-1,5SAK_ZRY,,0.0,,
+2497,Boltz-1,7QTA_URI,0.1111111111111111,0.9555555555555556,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+2498,Boltz-1,7RSV_7IQ,0.33333333333333326,0.8666666666666667,"{'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+2499,Boltz-1,8DSC_NCA,0.4285714285714285,0.8285714285714286,"{'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+2500,Boltz-1,7AKL_RK5,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+2501,Boltz-1,7XBV_APC,0.11111111111111105,0.9555555555555556,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2502,Boltz-1,7CNS_PMV,0.38888888888888895,0.8444444444444444,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2503,Boltz-1,7ZDY_6MJ,0.25,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+2504,Boltz-1,6Z4N_Q7B,0.2857142857142857,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+2505,Boltz-1,7NFB_GEN,,0.0,,
+2506,Boltz-1,7R7R_AWJ,0.2222222222222223,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2507,Boltz-1,7V14_ORU,0.1333333333333333,0.9466666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2508,Boltz-1,6YR2_T1C,0.40909090909090906,0.8363636363636364,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2509,Boltz-1,7JG0_GAR,0.18181818181818185,0.9272727272727272,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:V:VdWContact': 1}"
+2510,Boltz-1,7EBG_J0L,0.36363636363636354,0.8545454545454546,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2511,Boltz-1,8AY3_OE3,0.0625,0.975,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2512,Boltz-1,7M6K_YRJ,0.05882352941176472,0.9764705882352941,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2513,Boltz-1,6YT6_PKE,0.22727272727272718,0.9090909090909092,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2514,Boltz-1,7Q27_8KC,0.23809523809523808,0.9047619047619048,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2515,Boltz-1,8DHG_T78,0.1304347826086957,0.9478260869565217,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2516,Boltz-1,8EXL_799,0.15999999999999998,0.936,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+2517,Boltz-1,7FB7_8NF,0.2,0.92,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+2518,Boltz-1,7THI_PGA,0.4999999999999999,0.8,"{'UNL:ARG:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+2519,Boltz-1,6ZAE_ACV,0.125,0.95,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2520,Boltz-1,7MGY_ZD1,0.13333333333333336,0.9466666666666667,"{'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2521,Boltz-1,7XPO_UPG,0.20000000000000007,0.9199999999999999,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2522,Boltz-1,7SUC_COM,,0.0,,
+2523,Boltz-1,7BJJ_TVW,0.1,0.96,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2524,Boltz-1,7K0V_VQP,0.6551724137931033,0.7379310344827587,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2525,Boltz-1,7TE8_P0T,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 3, 'UNL:ASN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2526,Boltz-1,7QF4_RBF,0.04999999999999993,0.98,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 4, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+2527,Boltz-1,7UJ4_OQ4,0.1666666666666666,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+2528,Boltz-1,7A9H_TPP,0.1379310344827586,0.9448275862068966,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+2529,Boltz-1,7LEV_0JO,0.2380952380952382,0.9047619047619048,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2}"
+2530,Boltz-1,7N6F_0I1,,0.0,,
+2531,Boltz-1,8EAB_VN2,0.35714285714285726,0.8571428571428571,"{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2532,Boltz-1,6ZC3_JOR,0.2,0.92,"{'UNL:ARG:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2533,Boltz-1,7Q25_8J9,,0.0,,
+2534,Boltz-1,7C3U_AZG,0.1538461538461538,0.9384615384615385,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2}"
+2535,Boltz-1,7ROR_69X,0.033333333333333326,0.9866666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2536,Boltz-1,7MMH_ZJY,0.07142857142857141,0.9714285714285714,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2537,Boltz-1,7TH4_FFO,0.3181818181818182,0.8727272727272728,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2538,Boltz-1,8D39_QDB,,0.0,,
+2539,Boltz-1,7YZU_DO7,0.38888888888888884,0.8444444444444444,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+2540,Boltz-1,5SB2_1K2,0.16000000000000006,0.9359999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2541,Boltz-1,6M73_FNR,0.10714285714285712,0.9571428571428572,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2542,Boltz-1,8B8H_OJQ,0.13793103448275867,0.9448275862068966,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+2543,Boltz-1,7TOM_5AD,0.26086956521739135,0.8956521739130434,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2544,Boltz-1,7VWF_K55,0.15384615384615385,0.9384615384615385,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+2545,Boltz-1,7XI7_4RI,0.16666666666666669,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2546,Boltz-1,7AN5_RDH,0.12000000000000002,0.952,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+2547,Boltz-1,7B2C_TP7,,0.0,,
+2548,Boltz-1,7B94_ANP,0.35000000000000003,0.86,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2549,Boltz-1,7NF0_BYN,0.032258064516129004,0.9870967741935484,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}"
+2550,Boltz-1,7WKL_CAQ,0.23076923076923073,0.9076923076923077,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2551,Boltz-1,7WPW_F15,0.2631578947368421,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2552,Boltz-1,8SLG_G5A,0.2941176470588236,0.8823529411764706,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+2553,Boltz-1,7RNI_60I,,0.0,,
+2554,Boltz-1,7SZA_DUI,0.15789473684210525,0.9368421052631579,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2555,Boltz-1,7PIH_7QW,0.1499999999999999,0.9400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2556,Boltz-1,7T3E_SLB,0.125,0.95,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+2557,Boltz-1,7FRX_O88,,0.0,,
+2558,Boltz-1,8CNH_V6U,0.38888888888888895,0.8444444444444444,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+2559,Boltz-1,7C8Q_DSG,,0.0,,
+2560,Boltz-1,7ZF0_DHR,0.25,0.9,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3}"
+2561,Boltz-1,8G0V_YHT,,0.0,,
+2562,Boltz-1,7P5T_5YG,,0.0,,
+2563,Boltz-1,7NU0_DCL,0.09090909090909091,0.9636363636363636,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2564,Boltz-1,6Z0R_Q4H,0.2727272727272727,0.8909090909090909,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}","{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}"
+2565,Boltz-1,7XRL_FWK,,0.0,,
+2566,Boltz-1,7LOU_IFM,0.07692307692307693,0.9692307692307692,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:UDP:VdWContact': 1}"
+2567,Boltz-1,7ROU_66I,0.09677419354838701,0.9612903225806452,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2568,Boltz-1,6XCT_478,0.38888888888888884,0.8444444444444444,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2569,Boltz-1,7LT0_ONJ,0.21052631578947378,0.9157894736842105,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2570,Boltz-1,7OLI_8HG,0.0625,0.975,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+2571,Boltz-1,7Z1Q_NIO,0.2,0.92,"{'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2572,Boltz-1,6YQW_82I,0.1,0.96,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2573,Boltz-1,6T88_MWQ,0.25,0.9,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2574,Boltz-1,7PRI_7TI,0.3846153846153845,0.8461538461538463,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1}"
+2575,Boltz-1,7OFF_VCB,0.13333333333333336,0.9466666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2576,Boltz-1,7DQL_4CL,0.39999999999999997,0.8400000000000001,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+2577,Boltz-1,7O1T_5X8,0.1,0.96,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2578,Boltz-1,7KM8_WPD,0.15000000000000008,0.94,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2579,Boltz-1,7ZXV_45D,0.2413793103448275,0.903448275862069,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL::Hydrophobic': 1, 'UNL::VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2580,Boltz-1,7X5N_5M5,0.09090909090909088,0.9636363636363636,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2581,Boltz-1,7VQ9_ISY,0.25,0.9,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+2582,Boltz-1,7PJQ_OWH,0.20000000000000007,0.9199999999999999,"{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2583,Boltz-1,8AQL_PLG,,0.0,,
+2584,Boltz-1,7VC5_9SF,0.3125,0.875,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2585,Boltz-1,7AFX_R9K,0.14285714285714288,0.9428571428571428,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+2586,Boltz-1,7RKW_5TV,,0.0,,
+2587,Boltz-1,7TYP_KUR,0.21739130434782622,0.9130434782608695,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2588,Boltz-1,7L03_F9F,0.05555555555555555,0.9777777777777777,"{'UNL:ALA:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2589,Boltz-1,7P1F_KFN,0.4285714285714286,0.8285714285714285,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2590,Boltz-1,7O0N_CDP,0.18181818181818182,0.9272727272727272,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2591,Boltz-1,7MYU_ZR7,0.0,1.0,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2592,Boltz-1,6YSP_PAL,0.1875,0.925,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+2593,Boltz-1,7XJN_NSD,0.39999999999999997,0.8400000000000001,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2594,Boltz-1,7R6J_2I7,,0.0,,
+2595,Boltz-1,8HFN_XGC,0.13043478260869562,0.9478260869565217,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2596,Boltz-1,7BTT_F8R,0.3333333333333334,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2597,Boltz-1,7MY1_IPE,0.18181818181818182,0.9272727272727272,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+2598,Boltz-1,8FO5_Y4U,1.1818181818181817,0.5272727272727273,"{'UNL:ASN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 7, 'UNL:TYR:VdWContact': 7}","{'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}"
+2599,Boltz-1,8AUH_L9I,0.28571428571428564,0.8857142857142858,"{'UNL:ALA:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+2600,Boltz-1,7ECR_SIN,,0.0,,
+2601,Boltz-1,6TW5_9M2,,0.0,,
+2602,Boltz-1,7ELT_TYM,0.07407407407407407,0.9703703703703703,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}"
+2603,Boltz-1,7D5C_GV6,0.18518518518518517,0.9259259259259259,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2604,Boltz-1,7W06_ITN,0.2941176470588236,0.8823529411764706,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+2605,Boltz-1,6YJA_2BA,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2606,Boltz-1,7P1M_4IU,0.19999999999999996,0.92,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+2607,Boltz-1,7PGX_FMN,0.09523809523809529,0.9619047619047619,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+2608,Boltz-1,7UAS_MBU,0.1875,0.925,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+2609,Boltz-1,8GFD_ZHR,0.29999999999999993,0.88,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2610,Boltz-1,7CTM_BDP,0.23076923076923084,0.9076923076923077,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CSD:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1}"
+2611,Boltz-1,7UQ3_O2U,0.07142857142857142,0.9714285714285714,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2612,Boltz-1,7DKT_GLF,0.08333333333333337,0.9666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+2613,Boltz-1,7CNQ_G8X,,0.0,,
+2614,Boltz-1,6Z1C_7EY,0.06666666666666665,0.9733333333333334,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}"
+2615,Boltz-1,7M3H_YPV,0.25,0.9,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1}"
+2616,Boltz-1,7D6O_MTE,,0.0,,
+2617,Boltz-1,7N4W_P4V,0.05555555555555555,0.9777777777777777,"{'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2618,Boltz-1,6Z2C_Q5E,0.07142857142857142,0.9714285714285714,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2619,Boltz-1,7CIJ_G0C,0.35,0.86,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2}"
+2620,Boltz-1,7USH_82V,0.16666666666666666,0.9333333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2621,Boltz-1,7XG5_PLP,0.20000000000000007,0.9199999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+2622,Boltz-1,7PT3_3KK,0.1250000000000001,0.95,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2623,Boltz-1,7KB1_WBJ,,0.0,,
+2624,Boltz-1,7WUX_6OI,,0.0,,
+2625,Boltz-1,7OZ9_NGK,0.5,0.8,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+2626,Boltz-1,7N03_ZRP,0.23529411764705885,0.9058823529411765,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2627,Boltz-1,7BMI_U4B,0.0,1.0,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2628,Boltz-1,7RZL_NPO,0.09999999999999998,0.96,"{'UNL:GLY:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2629,Boltz-1,7QHL_D5P,1.0416666666666665,0.5833333333333334,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2630,Boltz-1,7N7B_T3F,0.19047619047619052,0.9238095238095237,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2631,Boltz-1,7Q5I_I0F,0.14999999999999997,0.9400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+2632,Boltz-1,7BKA_4JC,0.3125,0.875,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2633,Boltz-1,7NXO_UU8,0.22727272727272724,0.9090909090909091,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2634,Boltz-1,6XG5_TOP,0.08333333333333337,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+2635,Boltz-1,6XBO_5MC,0.11111111111111113,0.9555555555555555,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+2636,Boltz-1,8DKO_TFB,0.125,0.95,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2637,Boltz-1,7LJN_GTP,,0.0,,
+2638,Boltz-1,7MOI_HPS,0.27272727272727276,0.8909090909090909,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}"
+2639,Boltz-1,8G6P_API,0.050000000000000044,0.98,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 2, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+2640,Boltz-1,7ULC_56B,0.13636363636363646,0.9454545454545454,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2641,Boltz-1,7RC3_SAH,0.23999999999999994,0.904,"{'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2642,Boltz-1,7SFO_98L,0.22222222222222218,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+2643,Boltz-1,8DP2_UMA,0.12499999999999997,0.95,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+2644,Boltz-1,7ZZW_KKW,,0.0,,
+2645,Boltz-1,7XFA_D9J,0.33333333333333326,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+2646,Boltz-1,7NP6_UK8,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2647,Boltz-1,7F5D_EUO,0.3333333333333334,0.8666666666666667,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2648,Boltz-1,6TW7_NZB,0.2857142857142857,0.8857142857142857,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2649,Boltz-1,7FHA_ADX,0.1428571428571428,0.9428571428571428,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+2650,Boltz-1,7ES1_UDP,0.11111111111111102,0.9555555555555556,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2651,Boltz-1,7OEO_V9Z,0.05882352941176472,0.9764705882352941,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2652,Boltz-1,7DUA_HJ0,0.1666666666666667,0.9333333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2653,Boltz-1,7BCP_GCO,0.3571428571428571,0.8571428571428572,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+2654,Boltz-1,7P2I_MFU,0.30769230769230765,0.8769230769230769,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}"
+2655,Boltz-1,7WDT_NGS,0.6428571428571429,0.7428571428571429,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+2656,Boltz-1,8AEM_LVF,0.33333333333333337,0.8666666666666667,"{'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2657,Boltz-1,7WY1_D0L,,0.0,,
+2658,Boltz-1,7KRU_ATP,0.2631578947368421,0.8947368421052632,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}"
+2659,Boltz-1,7P4C_5OV,0.21428571428571425,0.9142857142857143,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 2}"
+2660,Boltz-1,7MWN_WI5,0.18181818181818182,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+2661,Boltz-1,7ZHP_IQY,0.18181818181818174,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2662,Boltz-1,7W05_GMP,0.23076923076923078,0.9076923076923077,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+2663,Boltz-1,7UJF_R3V,0.26086956521739135,0.8956521739130434,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2664,Boltz-1,7LOE_Y84,0.25,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+2665,Boltz-1,8AIE_M7L,0.3125,0.875,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:VdWContact': 5, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+2666,Boltz-1,7JY3_VUD,,0.0,,
+2667,Boltz-1,6XM9_V55,0.2857142857142857,0.8857142857142857,"{'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2668,Boltz-1,7POM_7VZ,0.16666666666666663,0.9333333333333333,"{'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2669,Boltz-1,7M31_TDR,,0.0,,
+2670,Boltz-1,8EYE_X4I,0.1304347826086957,0.9478260869565217,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2671,Boltz-1,6YRV_PJ8,0.24999999999999997,0.9,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2672,Boltz-1,7LZD_YHY,0.5000000000000001,0.7999999999999999,"{'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2673,Boltz-1,7EPV_FDA,0.2399999999999999,0.904,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+2674,Boltz-1,7UY4_SMI,0.3571428571428571,0.8571428571428572,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2675,Boltz-1,7N4N_0BK,0.2666666666666666,0.8933333333333333,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2676,Boltz-1,7UMW_NAD,0.04,0.984,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2677,Boltz-1,7U3J_L6U,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+2678,Boltz-1,6Z14_Q4Z,0.23076923076923078,0.9076923076923077,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2679,Boltz-1,6ZK5_IMH,0.30000000000000004,0.88,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2680,Boltz-1,7QGP_DJ8,0.23809523809523808,0.9047619047619048,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2681,Boltz-1,7L5F_XNG,0.18181818181818196,0.9272727272727272,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2682,Boltz-1,7FT9_4MB,0.23529411764705882,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+2683,Boltz-1,7OP9_06K,,0.0,,
+2684,Boltz-1,7JXX_VP7,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2685,Boltz-1,7CL8_TES,,0.0,,
+2686,Boltz-1,7TM6_GPJ,0.14285714285714293,0.9428571428571428,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+2687,Boltz-1,7WQQ_5Z6,0.1333333333333333,0.9466666666666667,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2688,Boltz-1,7WL4_JFU,0.1666666666666666,0.9333333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2689,Boltz-1,7SCW_GSP,0.15999999999999998,0.936,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+2690,Boltz-1,7L7C_XQ1,0.15384615384615385,0.9384615384615385,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+2691,Boltz-1,7PUV_84Z,0.1333333333333333,0.9466666666666667,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2692,Boltz-1,7KQU_YOF,,0.0,,
+2693,Boltz-1,7Z2O_IAJ,0.14285714285714285,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+2694,Boltz-1,7PRM_81I,0.2692307692307691,0.8923076923076924,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2695,Boltz-1,8FLV_ZB9,0.17391304347826095,0.9304347826086956,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2696,Boltz-1,7NLV_UJE,0.17647058823529416,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+2697,Boltz-1,7T0D_FPP,,0.0,,
+2698,Boltz-1,7MWU_ZPM,0.4000000000000001,0.84,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2699,Boltz-1,7L00_XCJ,0.31818181818181823,0.8727272727272727,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2700,Boltz-1,8C5M_MTA,,0.0,,
+2701,Boltz-1,7Z7F_IF3,0.23076923076923078,0.9076923076923077,"{'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+2702,Boltz-1,7TSF_H4B,,0.0,,
+2703,Boltz-1,7TUO_KL9,0.44444444444444453,0.8222222222222222,"{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2704,Boltz-1,7ED2_A3P,0.2777777777777778,0.8888888888888888,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2705,Boltz-1,7ZL5_IWE,0.5714285714285714,0.7714285714285715,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 6, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+2706,Boltz-1,8F8E_XJI,0.6086956521739129,0.7565217391304349,"{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2707,Boltz-1,7OZC_G6S,0.21428571428571436,0.9142857142857143,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+2708,Boltz-1,7Q2B_M6H,0.3,0.88,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2709,Boltz-1,6VTA_AKN,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+2710,Boltz-1,7V3N_AKG,0.3333333333333333,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2711,Boltz-1,8F4J_PHO,,0.0,,
+2712,Boltz-1,7ZOC_T8E,0.21428571428571422,0.9142857142857144,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2713,Boltz-1,7WCF_ACP,0.0769230769230769,0.9692307692307692,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 4, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+2714,Boltz-1,7NUT_GLP,0.0625,0.975,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}"
+2715,Boltz-1,7E4L_MDN,0.2727272727272727,0.8909090909090909,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+2716,Boltz-1,7TS6_KMI,,0.0,,
+2717,Boltz-1,7NF3_4LU,0.03448275862068961,0.9862068965517241,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+2718,Boltz-1,8D5D_5DK,0.28571428571428575,0.8857142857142857,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2719,Boltz-1,7JMV_4NC,0.05555555555555555,0.9777777777777777,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2720,Boltz-1,7A9E_R4W,0.6153846153846153,0.7538461538461538,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+2721,Boltz-1,7TBU_S3P,0.6666666666666666,0.7333333333333334,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 2, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+2722,Boltz-1,7TB0_UD1,,0.0,,
+2723,Boltz-1,7MFP_Z7P,0.47058823529411764,0.8117647058823529,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 3, 'UNL:ASN:VdWContact': 5, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 5, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+2724,Boltz-1,6M2B_EZO,0.11111111111111116,0.9555555555555555,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2725,Boltz-1,7NPL_UKZ,0.44000000000000006,0.824,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2726,Boltz-1,7KZ9_XN7,0.16666666666666663,0.9333333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+2727,Boltz-1,7QE4_NGA,,0.0,,
+2728,Boltz-1,8AP0_PRP,0.19047619047619047,0.9238095238095239,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2729,Boltz-1,7V3S_5I9,0.19047619047619047,0.9238095238095239,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+2730,Boltz-1,7C0U_FGO,0.19999999999999998,0.92,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}"
+2731,Boltz-1,7UXS_OJC,0.26315789473684215,0.8947368421052632,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+2732,Boltz-1,7X9K_8OG,0.0,1.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2733,Boltz-1,8BOM_QU6,0.07999999999999996,0.968,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2734,Boltz-1,8BTI_RFO,0.21428571428571422,0.9142857142857144,"{'UNL:ALA:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2735,Boltz-1,7RWS_4UR,0.4444444444444444,0.8222222222222222,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2736,Boltz-1,6YQV_8K2,0.125,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2737,Boltz-1,7PK0_BYC,0.15999999999999992,0.936,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2738,Boltz-1,5SIS_JSM,0.05263157894736842,0.9789473684210527,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2739,Boltz-1,7NSW_HC4,0.09090909090909088,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2740,Boltz-1,7F8T_FAD,0.22580645161290328,0.9096774193548387,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2741,Boltz-1,5SD5_HWI,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2742,Boltz-1,7CUO_PHB,0.1111111111111111,0.9555555555555556,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2743,Boltz-1,7R3D_APR,0.3125,0.875,"{'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 5}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+2744,Boltz-1,7WJB_BGC,0.30769230769230776,0.8769230769230769,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+2745,Boltz-1,7A1P_QW2,0.05555555555555555,0.9777777777777777,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+2746,Boltz-1,6ZPB_3D1,0.3125,0.875,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2747,Boltz-1,7UTW_NAI,0.1363636363636364,0.9454545454545454,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+2748,Boltz-1,7WUY_76N,,0.0,,
+2749,Boltz-1,8A2D_KXY,0.22222222222222227,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 3, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+2750,Boltz-1,7NR8_UOE,,0.0,,
+2751,Boltz-1,7KC5_BJZ,0.7333333333333334,0.7066666666666667,"{'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2752,Boltz-1,7QPP_VDX,0.04999999999999993,0.98,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2753,Boltz-1,7VKZ_NOJ,0.3571428571428571,0.8571428571428572,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+2754,Boltz-1,7F51_BA7,0.22580645161290328,0.9096774193548387,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}"
+2755,Boltz-1,7PL1_SFG,0.125,0.95,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+2756,Boltz-1,7VB8_STL,,0.0,,
+2757,Boltz-1,8FAV_4Y5,0.7083333333333333,0.7166666666666667,"{'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2758,Boltz-1,7CD9_FVR,0.42105263157894746,0.831578947368421,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 4, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 5, 'UNL:TYR:VdWContact': 5}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}"
+2759,Boltz-1,7N7H_CTP,0.04166666666666666,0.9833333333333334,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2760,Boltz-1,7ODY_DGI,0.1904761904761904,0.9238095238095239,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2}"
+2761,Boltz-1,8CSD_C5P,0.3,0.88,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2762,Boltz-1,7OFK_VCH,0.09090909090909094,0.9636363636363636,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2763,Boltz-1,7SDD_4IP,0.3846153846153846,0.8461538461538461,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+2764,Boltz-1,7OPG_06N,0.39999999999999997,0.8400000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+2765,Boltz-1,7ZTL_BCN,0.4285714285714286,0.8285714285714285,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+2766,Boltz-1,7SIU_9ID,0.4782608695652174,0.808695652173913,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2767,Boltz-1,7LCU_XTA,0.3157894736842105,0.8736842105263158,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2768,Boltz-1,7NGW_UAW,0.10000000000000006,0.96,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2769,Boltz-1,7VYJ_CA0,,0.0,,
+2770,Boltz-1,7QHG_T3B,0.23333333333333342,0.9066666666666666,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+2771,Boltz-1,8HO0_3ZI,,0.0,,
+2772,AF3-Single-Seq,8AAU_LH0,0.3333333333333333,0.8666666666666667,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2773,AF3-Single-Seq,7JHQ_VAJ,0.5833333333333334,0.7666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2774,AF3-Single-Seq,6ZCY_QF8,0.16666666666666674,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2775,AF3-Single-Seq,7UAW_MF6,1.2105263157894735,0.5157894736842106,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+2776,AF3-Single-Seq,6YMS_OZH,0.36000000000000004,0.856,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2777,AF3-Single-Seq,7UJ5_DGL,0.4583333333333333,0.8166666666666667,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2778,AF3-Single-Seq,8EX2_Q2Q,,0.0,,
+2779,AF3-Single-Seq,7R9N_F97,0.5416666666666667,0.7833333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2780,AF3-Single-Seq,7UYB_OK0,0.20000000000000012,0.9199999999999999,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+2781,AF3-Single-Seq,7U0U_FK5,0.40625,0.8375,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 5, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2782,AF3-Single-Seq,7ZU2_DHT,0.3500000000000001,0.86,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2783,AF3-Single-Seq,6XHT_V2V,0.9444444444444445,0.6222222222222222,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 3, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+2784,AF3-Single-Seq,7OSO_0V1,0.07142857142857145,0.9714285714285714,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+2785,AF3-Single-Seq,8D19_GSH,0.09999999999999998,0.96,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+2786,AF3-Single-Seq,7MGT_ZD4,0.5185185185185185,0.7925925925925926,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2787,AF3-Single-Seq,8C3N_ADP,0.3125,0.875,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+2788,AF3-Single-Seq,6YYO_Q1K,1.375,0.44999999999999996,{},"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+2789,AF3-Single-Seq,8A1H_DLZ,0.9166666666666667,0.6333333333333333,"{'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+2790,AF3-Single-Seq,7XQZ_FPF,0.44000000000000017,0.824,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2791,AF3-Single-Seq,7RH3_59O,0.25,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+2792,AF3-Single-Seq,7OMX_CNA,0.7692307692307692,0.6923076923076923,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2793,AF3-Single-Seq,7LMO_NYO,0.3478260869565217,0.8608695652173913,"{'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2794,AF3-Single-Seq,7VBU_6I4,0.13043478260869573,0.9478260869565217,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2795,AF3-Single-Seq,7TXK_LW8,0.5294117647058825,0.788235294117647,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 4, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2796,AF3-Single-Seq,7T1D_E7K,0.6500000000000001,0.74,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 7, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2797,AF3-Single-Seq,7R59_I5F,0.41666666666666663,0.8333333333333334,"{'UNL:ASP:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2798,AF3-Single-Seq,7ZCC_OGA,,0.0,,
+2799,AF3-Single-Seq,7V43_C4O,0.5,0.8,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2800,AF3-Single-Seq,7BNH_BEZ,0.0,1.0,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+2801,AF3-Single-Seq,6WTN_RXT,0.2916666666666665,0.8833333333333334,"{'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2802,AF3-Single-Seq,7QFM_AY3,0.05882352941176472,0.9764705882352941,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2803,AF3-Single-Seq,7MSR_DCA,0.13333333333333341,0.9466666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2804,AF3-Single-Seq,5SAK_ZRY,,0.0,,
+2805,AF3-Single-Seq,7QTA_URI,0.39999999999999997,0.8400000000000001,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+2806,AF3-Single-Seq,7RSV_7IQ,0.42105263157894735,0.8315789473684211,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+2807,AF3-Single-Seq,8DSC_NCA,0.5882352941176472,0.7647058823529411,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+2808,AF3-Single-Seq,7AKL_RK5,0.24,0.904,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+2809,AF3-Single-Seq,7XBV_APC,0.38709677419354843,0.8451612903225807,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2810,AF3-Single-Seq,7CNS_PMV,0.6818181818181817,0.7272727272727273,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2811,AF3-Single-Seq,7ZDY_6MJ,0.36363636363636354,0.8545454545454546,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+2812,AF3-Single-Seq,6Z4N_Q7B,0.47619047619047633,0.8095238095238095,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 4, 'UNL:GLY:VdWContact': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+2813,AF3-Single-Seq,7NFB_GEN,0.5454545454545454,0.7818181818181819,"{'UNL:HIS:VdWContact': 1, 'UNL:LIG:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+2814,AF3-Single-Seq,7R7R_AWJ,0.17857142857142855,0.9285714285714286,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2815,AF3-Single-Seq,7V14_ORU,0.4444444444444445,0.8222222222222222,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2816,AF3-Single-Seq,6YR2_T1C,0.2916666666666667,0.8833333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2817,AF3-Single-Seq,7JG0_GAR,0.0,1.0,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:V:VdWContact': 1}"
+2818,AF3-Single-Seq,7EBG_J0L,0.5714285714285714,0.7714285714285715,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2819,AF3-Single-Seq,8AY3_OE3,0.30000000000000004,0.88,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2820,AF3-Single-Seq,7M6K_YRJ,0.050000000000000044,0.98,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2821,AF3-Single-Seq,6YT6_PKE,0.5217391304347827,0.7913043478260869,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2822,AF3-Single-Seq,7Q27_8KC,0.16000000000000014,0.9359999999999999,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2823,AF3-Single-Seq,8DHG_T78,0.5555555555555556,0.7777777777777778,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2824,AF3-Single-Seq,8EXL_799,0.2692307692307692,0.8923076923076924,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 5, 'UNL:MET:VdWContact': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+2825,AF3-Single-Seq,7FB7_8NF,0.3125,0.875,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+2826,AF3-Single-Seq,7THI_PGA,0.33333333333333337,0.8666666666666667,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 5}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+2827,AF3-Single-Seq,6ZAE_ACV,0.2142857142857143,0.9142857142857143,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 4, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2828,AF3-Single-Seq,7MGY_ZD1,0.10000000000000003,0.96,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2829,AF3-Single-Seq,7XPO_UPG,0.6190476190476191,0.7523809523809524,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2830,AF3-Single-Seq,7SUC_COM,,0.0,,
+2831,AF3-Single-Seq,7BJJ_TVW,0.2142857142857143,0.9142857142857143,"{'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2832,AF3-Single-Seq,7K0V_VQP,0.5357142857142858,0.7857142857142857,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2833,AF3-Single-Seq,7TE8_P0T,0.4166666666666667,0.8333333333333333,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2834,AF3-Single-Seq,7QF4_RBF,0.8571428571428572,0.6571428571428571,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+2835,AF3-Single-Seq,7UJ4_OQ4,0.5909090909090908,0.7636363636363637,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+2836,AF3-Single-Seq,7A9H_TPP,0.1538461538461538,0.9384615384615385,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+2837,AF3-Single-Seq,7LEV_0JO,0.39130434782608703,0.8434782608695652,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2}"
+2838,AF3-Single-Seq,7N6F_0I1,0.4545454545454546,0.8181818181818181,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 5, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2839,AF3-Single-Seq,8EAB_VN2,0.4444444444444446,0.8222222222222222,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 6}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2840,AF3-Single-Seq,6ZC3_JOR,0.5882352941176471,0.7647058823529411,"{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2841,AF3-Single-Seq,7Q25_8J9,,0.0,,
+2842,AF3-Single-Seq,7C3U_AZG,0.6153846153846154,0.7538461538461538,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2}"
+2843,AF3-Single-Seq,7ROR_69X,0.2195121951219512,0.9121951219512195,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2844,AF3-Single-Seq,7MMH_ZJY,0.4838709677419354,0.8064516129032259,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2845,AF3-Single-Seq,7TH4_FFO,0.45833333333333337,0.8166666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2846,AF3-Single-Seq,8D39_QDB,0.17647058823529416,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2847,AF3-Single-Seq,7YZU_DO7,0.3333333333333334,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+2848,AF3-Single-Seq,5SB2_1K2,0.3571428571428571,0.8571428571428572,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2849,AF3-Single-Seq,6M73_FNR,0.1470588235294118,0.9411764705882353,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2850,AF3-Single-Seq,8B8H_OJQ,0.49999999999999994,0.8,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+2851,AF3-Single-Seq,7TOM_5AD,0.5909090909090909,0.7636363636363637,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2852,AF3-Single-Seq,7VWF_K55,0.6071428571428571,0.7571428571428571,"{'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+2853,AF3-Single-Seq,7XI7_4RI,0.375,0.85,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2854,AF3-Single-Seq,7AN5_RDH,1.0454545454545454,0.5818181818181818,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+2855,AF3-Single-Seq,7B2C_TP7,,0.0,,
+2856,AF3-Single-Seq,7B94_ANP,0.6086956521739131,0.7565217391304347,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2857,AF3-Single-Seq,7NF0_BYN,0.5277777777777778,0.7888888888888889,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}"
+2858,AF3-Single-Seq,7WKL_CAQ,0.3125,0.875,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2859,AF3-Single-Seq,7WPW_F15,0.22222222222222227,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2860,AF3-Single-Seq,8SLG_G5A,0.47826086956521735,0.808695652173913,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+2861,AF3-Single-Seq,7RNI_60I,,0.0,,
+2862,AF3-Single-Seq,7SZA_DUI,0.38095238095238104,0.8476190476190476,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2863,AF3-Single-Seq,7PIH_7QW,0.18518518518518506,0.9259259259259259,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2864,AF3-Single-Seq,7T3E_SLB,0.09523809523809523,0.9619047619047619,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+2865,AF3-Single-Seq,7FRX_O88,,0.0,,
+2866,AF3-Single-Seq,8CNH_V6U,0.3636363636363637,0.8545454545454545,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+2867,AF3-Single-Seq,7C8Q_DSG,,0.0,,
+2868,AF3-Single-Seq,7ZF0_DHR,0.25,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3}"
+2869,AF3-Single-Seq,8G0V_YHT,0.22727272727272724,0.9090909090909091,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2870,AF3-Single-Seq,7P5T_5YG,0.4999999999999999,0.8,"{'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2871,AF3-Single-Seq,7NU0_DCL,0.2142857142857143,0.9142857142857143,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2872,AF3-Single-Seq,6Z0R_Q4H,0.39999999999999997,0.8400000000000001,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2}","{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}"
+2873,AF3-Single-Seq,7XRL_FWK,0.10000000000000003,0.96,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2874,AF3-Single-Seq,7LOU_IFM,1.1111111111111112,0.5555555555555556,{},"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:UDP:VdWContact': 1}"
+2875,AF3-Single-Seq,7ROU_66I,0.4571428571428571,0.8171428571428572,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2876,AF3-Single-Seq,6XCT_478,0.2222222222222222,0.9111111111111111,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2877,AF3-Single-Seq,7LT0_ONJ,0.52,0.792,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 6, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2878,AF3-Single-Seq,7OLI_8HG,0.5555555555555557,0.7777777777777777,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+2879,AF3-Single-Seq,7Z1Q_NIO,0.06666666666666665,0.9733333333333334,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2880,AF3-Single-Seq,6YQW_82I,0.1818181818181818,0.9272727272727272,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2881,AF3-Single-Seq,6T88_MWQ,0.4375,0.825,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2882,AF3-Single-Seq,7PRI_7TI,0.25,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1}"
+2883,AF3-Single-Seq,7OFF_VCB,0.4375,0.825,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2884,AF3-Single-Seq,7DQL_4CL,0.5833333333333334,0.7666666666666666,"{'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+2885,AF3-Single-Seq,7O1T_5X8,0.13043478260869562,0.9478260869565217,"{'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2886,AF3-Single-Seq,7KM8_WPD,0.6,0.76,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2887,AF3-Single-Seq,7ZXV_45D,0.25806451612903236,0.896774193548387,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL::Hydrophobic': 1, 'UNL::VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2888,AF3-Single-Seq,7X5N_5M5,0.19999999999999996,0.92,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2889,AF3-Single-Seq,7VQ9_ISY,0.49999999999999994,0.8,"{'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+2890,AF3-Single-Seq,7PJQ_OWH,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2}","{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2891,AF3-Single-Seq,8AQL_PLG,0.6666666666666667,0.7333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2892,AF3-Single-Seq,7VC5_9SF,0.8461538461538461,0.6615384615384615,"{'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2893,AF3-Single-Seq,7AFX_R9K,0.4,0.84,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+2894,AF3-Single-Seq,7RKW_5TV,0.375,0.85,"{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2895,AF3-Single-Seq,7TYP_KUR,0.6363636363636361,0.7454545454545456,"{'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2896,AF3-Single-Seq,7L03_F9F,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2897,AF3-Single-Seq,7P1F_KFN,1.3333333333333333,0.4666666666666667,"{'UNL:ASP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2898,AF3-Single-Seq,7O0N_CDP,0.40909090909090906,0.8363636363636364,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2899,AF3-Single-Seq,7MYU_ZR7,0.26086956521739124,0.8956521739130435,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2900,AF3-Single-Seq,6YSP_PAL,0.95,0.62,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+2901,AF3-Single-Seq,7XJN_NSD,1.2727272727272725,0.49090909090909096,"{'UNL:GLU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2902,AF3-Single-Seq,7R6J_2I7,1.0666666666666669,0.5733333333333333,"{'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2903,AF3-Single-Seq,8HFN_XGC,0.5714285714285714,0.7714285714285715,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 6, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2904,AF3-Single-Seq,7BTT_F8R,0.47368421052631576,0.8105263157894738,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+2905,AF3-Single-Seq,7MY1_IPE,0.25,0.9,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+2906,AF3-Single-Seq,8FO5_Y4U,0.35714285714285704,0.8571428571428572,"{'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}"
+2907,AF3-Single-Seq,8AUH_L9I,0.5714285714285714,0.7714285714285715,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+2908,AF3-Single-Seq,7ECR_SIN,1.0909090909090908,0.5636363636363637,{'UNL:GLN:VdWContact': 1},"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2909,AF3-Single-Seq,6TW5_9M2,0.35,0.86,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2910,AF3-Single-Seq,7ELT_TYM,0.606060606060606,0.7575757575757576,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}"
+2911,AF3-Single-Seq,7D5C_GV6,0.11111111111111116,0.9555555555555555,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2912,AF3-Single-Seq,7W06_ITN,1.1666666666666667,0.5333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+2913,AF3-Single-Seq,6YJA_2BA,0.75,0.7,"{'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 4, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2914,AF3-Single-Seq,7P1M_4IU,0.35294117647058826,0.8588235294117648,"{'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+2915,AF3-Single-Seq,7PGX_FMN,0.5217391304347826,0.7913043478260869,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+2916,AF3-Single-Seq,7UAS_MBU,0.2777777777777777,0.888888888888889,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+2917,AF3-Single-Seq,8GFD_ZHR,0.11764705882352938,0.9529411764705883,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2918,AF3-Single-Seq,7CTM_BDP,0.4615384615384616,0.8153846153846154,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CSD:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1}"
+2919,AF3-Single-Seq,7UQ3_O2U,0.10000000000000003,0.96,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2920,AF3-Single-Seq,7DKT_GLF,0.23529411764705888,0.9058823529411765,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+2921,AF3-Single-Seq,7CNQ_G8X,,0.0,,
+2922,AF3-Single-Seq,6Z1C_7EY,0.18181818181818182,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}"
+2923,AF3-Single-Seq,7M3H_YPV,0.3157894736842105,0.8736842105263158,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1}"
+2924,AF3-Single-Seq,7D6O_MTE,,0.0,,
+2925,AF3-Single-Seq,7N4W_P4V,0.27272727272727276,0.8909090909090909,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2926,AF3-Single-Seq,6Z2C_Q5E,0.14999999999999997,0.9400000000000001,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2927,AF3-Single-Seq,7CIJ_G0C,0.4545454545454544,0.8181818181818182,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 5, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2}"
+2928,AF3-Single-Seq,7USH_82V,0.7692307692307693,0.6923076923076923,"{'UNL:ARG:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2929,AF3-Single-Seq,7XG5_PLP,0.20000000000000007,0.9199999999999999,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+2930,AF3-Single-Seq,7PT3_3KK,0.5172413793103449,0.7931034482758621,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2931,AF3-Single-Seq,7KB1_WBJ,0.07142857142857151,0.9714285714285714,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+2932,AF3-Single-Seq,7WUX_6OI,,0.0,,
+2933,AF3-Single-Seq,7OZ9_NGK,0.5,0.8,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+2934,AF3-Single-Seq,7N03_ZRP,0.34782608695652173,0.8608695652173913,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2935,AF3-Single-Seq,7BMI_U4B,0.368421052631579,0.8526315789473684,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2936,AF3-Single-Seq,7RZL_NPO,0.18181818181818177,0.9272727272727272,"{'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2937,AF3-Single-Seq,7QHL_D5P,0.36363636363636376,0.8545454545454545,"{'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2938,AF3-Single-Seq,7N7B_T3F,0.21428571428571425,0.9142857142857143,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2939,AF3-Single-Seq,7Q5I_I0F,0.26086956521739135,0.8956521739130434,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+2940,AF3-Single-Seq,7BKA_4JC,0.38888888888888895,0.8444444444444444,"{'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2941,AF3-Single-Seq,7NXO_UU8,,0.0,,
+2942,AF3-Single-Seq,6XG5_TOP,0.8571428571428571,0.6571428571428571,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+2943,AF3-Single-Seq,6XBO_5MC,0.6190476190476191,0.7523809523809524,"{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+2944,AF3-Single-Seq,8DKO_TFB,1.125,0.55,{'UNL:PRO:VdWContact': 1},"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2945,AF3-Single-Seq,7LJN_GTP,0.5,0.8,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2946,AF3-Single-Seq,7MOI_HPS,0.4285714285714286,0.8285714285714285,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}"
+2947,AF3-Single-Seq,8G6P_API,0.8,0.6799999999999999,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+2948,AF3-Single-Seq,7ULC_56B,0.6363636363636364,0.7454545454545455,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2949,AF3-Single-Seq,7RC3_SAH,0.5217391304347827,0.7913043478260869,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+2950,AF3-Single-Seq,7SFO_98L,0.7391304347826086,0.7043478260869566,"{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+2951,AF3-Single-Seq,8DP2_UMA,0.32000000000000006,0.872,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+2952,AF3-Single-Seq,7ZZW_KKW,,0.0,,
+2953,AF3-Single-Seq,7XFA_D9J,0.4583333333333334,0.8166666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+2954,AF3-Single-Seq,7NP6_UK8,0.5714285714285714,0.7714285714285715,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2955,AF3-Single-Seq,7F5D_EUO,0.3333333333333333,0.8666666666666667,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2956,AF3-Single-Seq,6TW7_NZB,0.588235294117647,0.7647058823529412,"{'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+2957,AF3-Single-Seq,7FHA_ADX,0.29166666666666663,0.8833333333333333,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+2958,AF3-Single-Seq,7ES1_UDP,0.10344827586206895,0.9586206896551724,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2959,AF3-Single-Seq,7OEO_V9Z,0.5263157894736843,0.7894736842105263,"{'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+2960,AF3-Single-Seq,7DUA_HJ0,0.4,0.84,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2961,AF3-Single-Seq,7BCP_GCO,0.15789473684210525,0.9368421052631579,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+2962,AF3-Single-Seq,7P2I_MFU,0.16666666666666663,0.9333333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}"
+2963,AF3-Single-Seq,7WDT_NGS,0.4736842105263158,0.8105263157894737,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+2964,AF3-Single-Seq,8AEM_LVF,0.25,0.9,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2965,AF3-Single-Seq,7WY1_D0L,0.9090909090909091,0.6363636363636364,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2966,AF3-Single-Seq,7KRU_ATP,0.2608695652173914,0.8956521739130434,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 5, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}"
+2967,AF3-Single-Seq,7P4C_5OV,0.3157894736842105,0.8736842105263158,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 2}"
+2968,AF3-Single-Seq,7MWN_WI5,0.17391304347826086,0.9304347826086956,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+2969,AF3-Single-Seq,7ZHP_IQY,0.25000000000000006,0.9,"{'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2970,AF3-Single-Seq,7W05_GMP,0.3636363636363636,0.8545454545454545,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+2971,AF3-Single-Seq,7UJF_R3V,0.17391304347826098,0.9304347826086956,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2972,AF3-Single-Seq,7LOE_Y84,0.3571428571428571,0.8571428571428572,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+2973,AF3-Single-Seq,8AIE_M7L,0.5555555555555557,0.7777777777777777,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+2974,AF3-Single-Seq,7JY3_VUD,0.06666666666666665,0.9733333333333334,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+2975,AF3-Single-Seq,6XM9_V55,0.3125,0.875,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+2976,AF3-Single-Seq,7POM_7VZ,0.20000000000000012,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2977,AF3-Single-Seq,7M31_TDR,,0.0,,
+2978,AF3-Single-Seq,8EYE_X4I,0.44444444444444464,0.8222222222222222,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2979,AF3-Single-Seq,6YRV_PJ8,0.041666666666666685,0.9833333333333333,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2980,AF3-Single-Seq,7LZD_YHY,0.13043478260869557,0.9478260869565218,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+2981,AF3-Single-Seq,7EPV_FDA,0.21428571428571422,0.9142857142857144,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 5, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+2982,AF3-Single-Seq,7UY4_SMI,0.16666666666666669,0.9333333333333333,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+2983,AF3-Single-Seq,7N4N_0BK,0.23076923076923078,0.9076923076923077,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+2984,AF3-Single-Seq,7UMW_NAD,0.3448275862068966,0.8620689655172413,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+2985,AF3-Single-Seq,7U3J_L6U,0.4074074074074075,0.837037037037037,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+2986,AF3-Single-Seq,6Z14_Q4Z,0.17647058823529416,0.9294117647058824,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+2987,AF3-Single-Seq,6ZK5_IMH,0.6818181818181818,0.7272727272727273,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2988,AF3-Single-Seq,7QGP_DJ8,0.13793103448275862,0.9448275862068966,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+2989,AF3-Single-Seq,7L5F_XNG,0.8999999999999999,0.64,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2990,AF3-Single-Seq,7FT9_4MB,0.7272727272727274,0.709090909090909,"{'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+2991,AF3-Single-Seq,7OP9_06K,,0.0,,
+2992,AF3-Single-Seq,7JXX_VP7,0.52,0.792,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2993,AF3-Single-Seq,7CL8_TES,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+2994,AF3-Single-Seq,7TM6_GPJ,1.2307692307692308,0.5076923076923077,{'UNL:PRO:VdWContact': 1},"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+2995,AF3-Single-Seq,7WQQ_5Z6,0.3500000000000001,0.86,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2996,AF3-Single-Seq,7WL4_JFU,0.7777777777777777,0.6888888888888889,"{'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+2997,AF3-Single-Seq,7SCW_GSP,0.25925925925925936,0.8962962962962963,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+2998,AF3-Single-Seq,7L7C_XQ1,0.42857142857142855,0.8285714285714285,"{'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:GLN:Hydrophobic': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+2999,AF3-Single-Seq,7PUV_84Z,0.19047619047619058,0.9238095238095237,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3000,AF3-Single-Seq,7KQU_YOF,0.5238095238095237,0.7904761904761906,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+3001,AF3-Single-Seq,7Z2O_IAJ,0.21052631578947367,0.9157894736842105,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+3002,AF3-Single-Seq,7PRM_81I,0.4782608695652173,0.808695652173913,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3003,AF3-Single-Seq,8FLV_ZB9,0.40740740740740733,0.837037037037037,"{'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3004,AF3-Single-Seq,7NLV_UJE,1.0526315789473684,0.5789473684210527,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+3005,AF3-Single-Seq,7T0D_FPP,,0.0,,
+3006,AF3-Single-Seq,7MWU_ZPM,0.33333333333333337,0.8666666666666667,"{'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+3007,AF3-Single-Seq,7L00_XCJ,0.1111111111111111,0.9555555555555556,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3008,AF3-Single-Seq,8C5M_MTA,0.9333333333333333,0.6266666666666667,"{'UNL:GLY:VdWContact': 1, 'UNL:MET:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3009,AF3-Single-Seq,7Z7F_IF3,0.3333333333333334,0.8666666666666667,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+3010,AF3-Single-Seq,7TSF_H4B,0.24999999999999994,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+3011,AF3-Single-Seq,7TUO_KL9,0.4545454545454545,0.8181818181818182,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3012,AF3-Single-Seq,7ED2_A3P,0.8333333333333333,0.6666666666666667,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+3013,AF3-Single-Seq,7ZL5_IWE,0.5263157894736843,0.7894736842105263,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 6, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+3014,AF3-Single-Seq,8F8E_XJI,0.3636363636363637,0.8545454545454545,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3015,AF3-Single-Seq,7OZC_G6S,0.3529411764705883,0.8588235294117647,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+3016,AF3-Single-Seq,7Q2B_M6H,0.13333333333333336,0.9466666666666667,"{'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3017,AF3-Single-Seq,6VTA_AKN,0.42857142857142855,0.8285714285714285,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+3018,AF3-Single-Seq,7V3N_AKG,0.2857142857142857,0.8857142857142857,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3019,AF3-Single-Seq,8F4J_PHO,,0.0,,
+3020,AF3-Single-Seq,7ZOC_T8E,0.16666666666666669,0.9333333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+3021,AF3-Single-Seq,7WCF_ACP,0.24137931034482757,0.903448275862069,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+3022,AF3-Single-Seq,7NUT_GLP,0.4736842105263159,0.8105263157894737,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}"
+3023,AF3-Single-Seq,7E4L_MDN,1.1,0.5599999999999999,"{'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 5}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+3024,AF3-Single-Seq,7TS6_KMI,0.4166666666666667,0.8333333333333333,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3025,AF3-Single-Seq,7NF3_4LU,0.3243243243243243,0.8702702702702703,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+3026,AF3-Single-Seq,8D5D_5DK,0.1481481481481482,0.9407407407407408,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3027,AF3-Single-Seq,7JMV_4NC,0.55,0.78,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3028,AF3-Single-Seq,7A9E_R4W,0.1875,0.925,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+3029,AF3-Single-Seq,7TBU_S3P,0.5,0.8,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+3030,AF3-Single-Seq,7TB0_UD1,0.40740740740740755,0.837037037037037,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+3031,AF3-Single-Seq,7MFP_Z7P,0.6206896551724137,0.7517241379310345,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 5, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+3032,AF3-Single-Seq,6M2B_EZO,0.16666666666666657,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3033,AF3-Single-Seq,7NPL_UKZ,0.4482758620689655,0.8206896551724138,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 6, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3034,AF3-Single-Seq,7KZ9_XN7,0.8333333333333335,0.6666666666666666,"{'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+3035,AF3-Single-Seq,7QE4_NGA,,0.0,,
+3036,AF3-Single-Seq,8AP0_PRP,0.11111111111111116,0.9555555555555555,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+3037,AF3-Single-Seq,7V3S_5I9,0.17241379310344823,0.9310344827586207,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+3038,AF3-Single-Seq,7C0U_FGO,0.1428571428571428,0.9428571428571428,"{'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}"
+3039,AF3-Single-Seq,7UXS_OJC,0.2916666666666667,0.8833333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+3040,AF3-Single-Seq,7X9K_8OG,0.17857142857142855,0.9285714285714286,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3041,AF3-Single-Seq,8BOM_QU6,0.25,0.9,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3042,AF3-Single-Seq,8BTI_RFO,0.09999999999999992,0.9600000000000001,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3043,AF3-Single-Seq,7RWS_4UR,0.5714285714285713,0.7714285714285715,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3044,AF3-Single-Seq,6YQV_8K2,0.3333333333333334,0.8666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3045,AF3-Single-Seq,7PK0_BYC,0.18421052631578955,0.9263157894736842,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3046,AF3-Single-Seq,5SIS_JSM,0.4285714285714285,0.8285714285714286,"{'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3047,AF3-Single-Seq,7NSW_HC4,0.9,0.64,"{'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3048,AF3-Single-Seq,7F8T_FAD,0.5,0.8,"{'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3049,AF3-Single-Seq,5SD5_HWI,0.17391304347826098,0.9304347826086956,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+3050,AF3-Single-Seq,7CUO_PHB,0.29411764705882354,0.8823529411764706,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+3051,AF3-Single-Seq,7R3D_APR,0.3333333333333332,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+3052,AF3-Single-Seq,7WJB_BGC,0.6363636363636362,0.7454545454545455,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+3053,AF3-Single-Seq,7A1P_QW2,0.28,0.888,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+3054,AF3-Single-Seq,6ZPB_3D1,0.5238095238095238,0.7904761904761904,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3055,AF3-Single-Seq,7UTW_NAI,0.2962962962962963,0.8814814814814815,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+3056,AF3-Single-Seq,7WUY_76N,0.9473684210526316,0.6210526315789473,"{'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3057,AF3-Single-Seq,8A2D_KXY,0.2903225806451613,0.8838709677419355,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+3058,AF3-Single-Seq,7NR8_UOE,,0.0,,
+3059,AF3-Single-Seq,7KC5_BJZ,0.4000000000000001,0.84,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+3060,AF3-Single-Seq,7QPP_VDX,0.44444444444444453,0.8222222222222222,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+3061,AF3-Single-Seq,7VKZ_NOJ,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+3062,AF3-Single-Seq,7F51_BA7,0.05882352941176472,0.9764705882352941,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}"
+3063,AF3-Single-Seq,7PL1_SFG,0.15384615384615385,0.9384615384615385,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+3064,AF3-Single-Seq,7VB8_STL,,0.0,,
+3065,AF3-Single-Seq,8FAV_4Y5,0.7499999999999999,0.7000000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3066,AF3-Single-Seq,7CD9_FVR,0.26086956521739135,0.8956521739130434,"{'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}"
+3067,AF3-Single-Seq,7N7H_CTP,1.0,0.6,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+3068,AF3-Single-Seq,7ODY_DGI,0.9523809523809523,0.6190476190476191,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2}"
+3069,AF3-Single-Seq,8CSD_C5P,0.2727272727272728,0.8909090909090909,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3070,AF3-Single-Seq,7OFK_VCH,0.4,0.84,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+3071,AF3-Single-Seq,7SDD_4IP,0.33333333333333337,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+3072,AF3-Single-Seq,7OPG_06N,0.8,0.6799999999999999,"{'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+3073,AF3-Single-Seq,7ZTL_BCN,0.09999999999999998,0.96,"{'UNL:ASN:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+3074,AF3-Single-Seq,7SIU_9ID,0.39130434782608703,0.8434782608695652,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3075,AF3-Single-Seq,7LCU_XTA,0.3333333333333334,0.8666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3076,AF3-Single-Seq,7NGW_UAW,0.125,0.95,"{'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3077,AF3-Single-Seq,7VYJ_CA0,0.888888888888889,0.6444444444444444,"{'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3078,AF3-Single-Seq,7QHG_T3B,0.9285714285714286,0.6285714285714286,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+3079,AF3-Single-Seq,8HO0_3ZI,0.1578947368421053,0.9368421052631579,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3080,AF3,8AAU_LH0,0.411764705882353,0.8352941176470587,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3081,AF3,7JHQ_VAJ,0.2666666666666666,0.8933333333333333,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3082,AF3,6ZCY_QF8,0.10000000000000005,0.96,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+3083,AF3,7UAW_MF6,0.4705882352941177,0.8117647058823529,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+3084,AF3,6YMS_OZH,0.09523809523809518,0.9619047619047619,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3085,AF3,7UJ5_DGL,0.09523809523809523,0.9619047619047619,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+3086,AF3,8EX2_Q2Q,,0.0,,
+3087,AF3,7R9N_F97,0.4375,0.825,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+3088,AF3,7UYB_OK0,0.1333333333333333,0.9466666666666667,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+3089,AF3,7U0U_FK5,0.37037037037037035,0.8518518518518519,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+3090,AF3,7ZU2_DHT,0.25000000000000006,0.9,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 5, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 6, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3091,AF3,6XHT_V2V,0.14285714285714296,0.9428571428571428,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}"
+3092,AF3,7OSO_0V1,0.18181818181818182,0.9272727272727272,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+3093,AF3,8D19_GSH,0.33333333333333326,0.8666666666666667,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+3094,AF3,7MGT_ZD4,0.04166666666666667,0.9833333333333333,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3095,AF3,8C3N_ADP,0.3125,0.875,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+3096,AF3,6YYO_Q1K,1.375,0.44999999999999996,{},"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}"
+3097,AF3,8A1H_DLZ,0.2727272727272728,0.8909090909090909,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LIG:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+3098,AF3,7XQZ_FPF,0.18181818181818182,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3099,AF3,7RH3_59O,0.6000000000000001,0.76,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+3100,AF3,7OMX_CNA,0.30434782608695654,0.8782608695652174,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3101,AF3,7LMO_NYO,0.6190476190476192,0.7523809523809524,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3102,AF3,7VBU_6I4,0.21428571428571425,0.9142857142857143,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3103,AF3,7TXK_LW8,0.1333333333333333,0.9466666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+3104,AF3,7T1D_E7K,0.41666666666666674,0.8333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 7, 'UNL:PHE:VdWContact': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 7, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3105,AF3,7R59_I5F,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+3106,AF3,7ZCC_OGA,,0.0,,
+3107,AF3,7V43_C4O,0.5714285714285714,0.7714285714285715,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+3108,AF3,7BNH_BEZ,0.5,0.8,"{'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+3109,AF3,6WTN_RXT,0.23529411764705885,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3110,AF3,7QFM_AY3,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3111,AF3,7MSR_DCA,0.13043478260869557,0.9478260869565218,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3112,AF3,5SAK_ZRY,,0.0,,
+3113,AF3,7QTA_URI,0.2222222222222222,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+3114,AF3,7RSV_7IQ,0.16666666666666674,0.9333333333333333,"{'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+3115,AF3,8DSC_NCA,0.4285714285714285,0.8285714285714286,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+3116,AF3,7AKL_RK5,0.0625,0.975,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+3117,AF3,7XBV_APC,0.05555555555555547,0.9777777777777779,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3118,AF3,7CNS_PMV,0.22222222222222227,0.9111111111111111,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+3119,AF3,7ZDY_6MJ,0.49999999999999994,0.8,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+3120,AF3,6Z4N_Q7B,0.125,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+3121,AF3,7NFB_GEN,0.07142857142857142,0.9714285714285714,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1}"
+3122,AF3,7R7R_AWJ,0.17647058823529416,0.9294117647058824,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3123,AF3,7V14_ORU,0.1875,0.925,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3124,AF3,6YR2_T1C,0.3157894736842105,0.8736842105263158,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+3125,AF3,7JG0_GAR,0.07692307692307693,0.9692307692307692,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:V:VdWContact': 1}"
+3126,AF3,7EBG_J0L,0.18181818181818188,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3127,AF3,8AY3_OE3,0.23529411764705876,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+3128,AF3,7M6K_YRJ,0.16666666666666674,0.9333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3129,AF3,6YT6_PKE,0.10000000000000003,0.96,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3130,AF3,7Q27_8KC,0.2777777777777777,0.888888888888889,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 3, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+3131,AF3,8DHG_T78,0.14285714285714285,0.9428571428571428,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 5, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+3132,AF3,8EXL_799,0.20833333333333331,0.9166666666666666,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+3133,AF3,7FB7_8NF,0.08333333333333337,0.9666666666666667,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}"
+3134,AF3,7THI_PGA,0.23076923076923078,0.9076923076923077,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+3135,AF3,6ZAE_ACV,0.0,1.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+3136,AF3,7MGY_ZD1,0.11764705882352944,0.9529411764705882,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+3137,AF3,7XPO_UPG,0.1578947368421053,0.9368421052631579,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+3138,AF3,7SUC_COM,,0.0,,
+3139,AF3,7BJJ_TVW,0.125,0.95,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3140,AF3,7K0V_VQP,0.0769230769230769,0.9692307692307692,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3141,AF3,7TE8_P0T,0.4761904761904762,0.8095238095238095,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+3142,AF3,7QF4_RBF,0.2499999999999999,0.9,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 4, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+3143,AF3,7UJ4_OQ4,0.1578947368421052,0.9368421052631579,"{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+3144,AF3,7A9H_TPP,0.0,1.0,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+3145,AF3,7LEV_0JO,0.10000000000000005,0.96,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 2}"
+3146,AF3,7N6F_0I1,0.05263157894736836,0.9789473684210527,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3147,AF3,8EAB_VN2,0.736842105263158,0.7052631578947368,"{'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+3148,AF3,6ZC3_JOR,0.3333333333333333,0.8666666666666667,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3149,AF3,7Q25_8J9,,0.0,,
+3150,AF3,7C3U_AZG,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2}"
+3151,AF3,7ROR_69X,0.06666666666666665,0.9733333333333334,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+3152,AF3,7MMH_ZJY,0.13793103448275856,0.9448275862068966,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3153,AF3,7TH4_FFO,0.0625,0.975,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3154,AF3,8D39_QDB,0.08333333333333337,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+3155,AF3,7YZU_DO7,0.16666666666666669,0.9333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+3156,AF3,5SB2_1K2,0.08333333333333341,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3157,AF3,6M73_FNR,0.07407407407407413,0.9703703703703703,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3158,AF3,8B8H_OJQ,0.18518518518518517,0.9259259259259259,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+3159,AF3,7TOM_5AD,0.13636363636363644,0.9454545454545454,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3160,AF3,7VWF_K55,0.2500000000000001,0.8999999999999999,"{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+3161,AF3,7XI7_4RI,0.25000000000000006,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3162,AF3,7AN5_RDH,0.3913043478260869,0.8434782608695652,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+3163,AF3,7B2C_TP7,,0.0,,
+3164,AF3,7B94_ANP,0.20000000000000007,0.9199999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3165,AF3,7NF0_BYN,0.09677419354838707,0.9612903225806452,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}"
+3166,AF3,7WKL_CAQ,0.07142857142857142,0.9714285714285714,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3167,AF3,7WPW_F15,0.0625,0.975,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3168,AF3,8SLG_G5A,0.5,0.8,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+3169,AF3,7RNI_60I,,0.0,,
+3170,AF3,7SZA_DUI,0.22222222222222213,0.9111111111111112,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3171,AF3,7PIH_7QW,0.21052631578947362,0.9157894736842106,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+3172,AF3,7T3E_SLB,0.3333333333333333,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+3173,AF3,7FRX_O88,,0.0,,
+3174,AF3,8CNH_V6U,0.3333333333333333,0.8666666666666667,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+3175,AF3,7C8Q_DSG,,0.0,,
+3176,AF3,7ZF0_DHR,0.3,0.88,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3}"
+3177,AF3,8G0V_YHT,0.21052631578947362,0.9157894736842106,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3178,AF3,7P5T_5YG,0.4166666666666667,0.8333333333333333,"{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3179,AF3,7NU0_DCL,0.18181818181818174,0.9272727272727272,"{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3180,AF3,6Z0R_Q4H,0.0,1.0,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}","{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1}"
+3181,AF3,7XRL_FWK,0.21428571428571433,0.9142857142857143,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3182,AF3,7LOU_IFM,0.1,0.96,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:UDP:VdWContact': 1}"
+3183,AF3,7ROU_66I,0.033333333333333326,0.9866666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+3184,AF3,6XCT_478,0.22222222222222213,0.9111111111111112,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3185,AF3,7LT0_ONJ,0.15789473684210537,0.9368421052631578,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+3186,AF3,7OLI_8HG,0.11764705882352942,0.9529411764705882,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}"
+3187,AF3,7Z1Q_NIO,0.2222222222222222,0.9111111111111111,"{'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+3188,AF3,6YQW_82I,0.19999999999999998,0.92,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3189,AF3,6T88_MWQ,0.3333333333333333,0.8666666666666667,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3190,AF3,7PRI_7TI,0.13333333333333336,0.9466666666666667,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1}"
+3191,AF3,7OFF_VCB,0.25,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+3192,AF3,7DQL_4CL,0.16666666666666657,0.9333333333333333,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+3193,AF3,7O1T_5X8,0.10000000000000005,0.96,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+3194,AF3,7KM8_WPD,0.10000000000000003,0.96,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+3195,AF3,7ZXV_45D,0.357142857142857,0.8571428571428572,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 3, 'UNL:THR:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL::Hydrophobic': 1, 'UNL::VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 5, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+3196,AF3,7X5N_5M5,0.1111111111111111,0.9555555555555556,"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3197,AF3,7VQ9_ISY,0.0,1.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+3198,AF3,7PJQ_OWH,0.09999999999999998,0.96,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+3199,AF3,8AQL_PLG,0.2631578947368421,0.8947368421052632,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3200,AF3,7VC5_9SF,0.4705882352941176,0.8117647058823529,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3201,AF3,7AFX_R9K,0.42857142857142855,0.8285714285714285,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+3202,AF3,7RKW_5TV,0.4166666666666667,0.8333333333333333,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3203,AF3,7TYP_KUR,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 6, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3204,AF3,7L03_F9F,0.05555555555555555,0.9777777777777777,"{'UNL:ALA:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3205,AF3,7P1F_KFN,0.25,0.9,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3206,AF3,7O0N_CDP,0.09523809523809529,0.9619047619047619,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 5, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+3207,AF3,7MYU_ZR7,0.26086956521739124,0.8956521739130435,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+3208,AF3,6YSP_PAL,0.11764705882352942,0.9529411764705882,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}"
+3209,AF3,7XJN_NSD,0.16666666666666663,0.9333333333333333,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+3210,AF3,7R6J_2I7,1.1428571428571428,0.5428571428571429,"{'UNL:ARG:VdWContact': 1, 'UNL:LIG:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3211,AF3,8HFN_XGC,0.21739130434782605,0.9130434782608696,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3212,AF3,7BTT_F8R,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+3213,AF3,7MY1_IPE,0.1,0.96,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+3214,AF3,8FO5_Y4U,0.9,0.64,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}"
+3215,AF3,8AUH_L9I,0.3076923076923077,0.8769230769230769,"{'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+3216,AF3,7ECR_SIN,0.75,0.7,"{'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3217,AF3,6TW5_9M2,0.07142857142857151,0.9714285714285714,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3218,AF3,7ELT_TYM,0.18518518518518517,0.9259259259259259,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 3}"
+3219,AF3,7D5C_GV6,0.0869565217391304,0.9652173913043478,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3220,AF3,7W06_ITN,0.2857142857142857,0.8857142857142857,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+3221,AF3,6YJA_2BA,0.0,1.0,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3222,AF3,7P1M_4IU,0.0,1.0,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+3223,AF3,7PGX_FMN,0.2380952380952382,0.9047619047619048,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 4, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+3224,AF3,7UAS_MBU,0.33333333333333337,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+3225,AF3,8GFD_ZHR,0.06666666666666665,0.9733333333333334,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3226,AF3,7CTM_BDP,0.08333333333333333,0.9666666666666667,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CSD:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1}"
+3227,AF3,7UQ3_O2U,0.125,0.95,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3228,AF3,7DKT_GLF,0.2727272727272727,0.8909090909090909,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+3229,AF3,7CNQ_G8X,,0.0,,
+3230,AF3,6Z1C_7EY,0.06666666666666676,0.9733333333333333,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}"
+3231,AF3,7M3H_YPV,0.3571428571428572,0.8571428571428571,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 4, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1}"
+3232,AF3,7D6O_MTE,,0.0,,
+3233,AF3,7N4W_P4V,0.0625,0.975,"{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3234,AF3,6Z2C_Q5E,0.20000000000000007,0.9199999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3235,AF3,7CIJ_G0C,0.3157894736842105,0.8736842105263158,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2}"
+3236,AF3,7USH_82V,0.08333333333333333,0.9666666666666667,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+3237,AF3,7XG5_PLP,0.06666666666666667,0.9733333333333334,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+3238,AF3,7PT3_3KK,0.2272727272727273,0.9090909090909091,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3239,AF3,7KB1_WBJ,0.15000000000000002,0.94,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+3240,AF3,7WUX_6OI,,0.0,,
+3241,AF3,7OZ9_NGK,0.0,1.0,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+3242,AF3,7N03_ZRP,0.3529411764705883,0.8588235294117647,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3243,AF3,7BMI_U4B,0.15384615384615385,0.9384615384615385,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3244,AF3,7RZL_NPO,0.10000000000000003,0.96,"{'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3245,AF3,7QHL_D5P,0.21052631578947367,0.9157894736842105,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3246,AF3,7N7B_T3F,0.1,0.96,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+3247,AF3,7Q5I_I0F,0.0,1.0,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+3248,AF3,7BKA_4JC,0.1875,0.925,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3249,AF3,7NXO_UU8,0.1818181818181818,0.9272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3250,AF3,6XG5_TOP,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+3251,AF3,6XBO_5MC,0.058823529411764705,0.9764705882352941,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}"
+3252,AF3,8DKO_TFB,0.125,0.95,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+3253,AF3,7LJN_GTP,0.23529411764705876,0.9058823529411765,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+3254,AF3,7MOI_HPS,0.27272727272727276,0.8909090909090909,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1}"
+3255,AF3,8G6P_API,0.07142857142857142,0.9714285714285714,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+3256,AF3,7ULC_56B,0.2500000000000001,0.8999999999999999,"{'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+3257,AF3,7RC3_SAH,0.1904761904761904,0.9238095238095239,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+3258,AF3,7SFO_98L,0.23529411764705888,0.9058823529411765,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+3259,AF3,8DP2_UMA,0.12000000000000004,0.952,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+3260,AF3,7ZZW_KKW,,0.0,,
+3261,AF3,7XFA_D9J,0.24999999999999992,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+3262,AF3,7NP6_UK8,0.25,0.9,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3263,AF3,7F5D_EUO,0.2857142857142857,0.8857142857142857,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3264,AF3,6TW7_NZB,0.18181818181818185,0.9272727272727272,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+3265,AF3,7FHA_ADX,0.25,0.9,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1}"
+3266,AF3,7ES1_UDP,0.10526315789473689,0.9578947368421052,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3267,AF3,7OEO_V9Z,0.16666666666666666,0.9333333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+3268,AF3,7DUA_HJ0,0.2631578947368421,0.8947368421052632,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3269,AF3,7BCP_GCO,0.07692307692307693,0.9692307692307692,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}"
+3270,AF3,7P2I_MFU,0.09090909090909094,0.9636363636363636,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}"
+3271,AF3,7WDT_NGS,0.19999999999999998,0.92,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+3272,AF3,8AEM_LVF,0.5333333333333334,0.7866666666666666,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3273,AF3,7WY1_D0L,0.0869565217391304,0.9652173913043478,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3274,AF3,7KRU_ATP,0.33333333333333326,0.8666666666666667,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 6, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}"
+3275,AF3,7P4C_5OV,0.09090909090909094,0.9636363636363636,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:VdWContact': 2}"
+3276,AF3,7MWN_WI5,0.09999999999999995,0.96,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+3277,AF3,7ZHP_IQY,0.17391304347826084,0.9304347826086956,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3278,AF3,7W05_GMP,0.07692307692307693,0.9692307692307692,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+3279,AF3,7UJF_R3V,0.23809523809523808,0.9047619047619048,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+3280,AF3,7LOE_Y84,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+3281,AF3,8AIE_M7L,0.3125,0.875,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+3282,AF3,7JY3_VUD,0.2666666666666668,0.8933333333333333,"{'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+3283,AF3,6XM9_V55,0.125,0.95,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3284,AF3,7POM_7VZ,0.14285714285714282,0.9428571428571428,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3285,AF3,7M31_TDR,,0.0,,
+3286,AF3,8EYE_X4I,0.14285714285714285,0.9428571428571428,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3287,AF3,6YRV_PJ8,0.2727272727272729,0.8909090909090909,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3288,AF3,7LZD_YHY,0.21428571428571444,0.9142857142857143,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+3289,AF3,7EPV_FDA,0.04166666666666663,0.9833333333333334,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+3290,AF3,7UY4_SMI,0.5384615384615384,0.7846153846153846,"{'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+3291,AF3,7N4N_0BK,0.25,0.9,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+3292,AF3,7UMW_NAD,0.08333333333333329,0.9666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3293,AF3,7U3J_L6U,0.28,0.888,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+3294,AF3,6Z14_Q4Z,0.24999999999999992,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+3295,AF3,6ZK5_IMH,0.11111111111111102,0.9555555555555556,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3296,AF3,7QGP_DJ8,0.0,1.0,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3297,AF3,7L5F_XNG,0.2777777777777778,0.8888888888888888,"{'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3298,AF3,7FT9_4MB,0.28571428571428564,0.8857142857142858,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+3299,AF3,7OP9_06K,,0.0,,
+3300,AF3,7JXX_VP7,0.0,1.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3301,AF3,7CL8_TES,0.23076923076923078,0.9076923076923077,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3302,AF3,7TM6_GPJ,0.13333333333333336,0.9466666666666667,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+3303,AF3,7WQQ_5Z6,0.411764705882353,0.8352941176470587,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3304,AF3,7WL4_JFU,0.04999999999999999,0.98,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3305,AF3,7SCW_GSP,0.2962962962962963,0.8814814814814815,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+3306,AF3,7L7C_XQ1,0.16666666666666669,0.9333333333333333,"{'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+3307,AF3,7PUV_84Z,0.19999999999999998,0.92,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3308,AF3,7KQU_YOF,0.29411764705882354,0.8823529411764706,"{'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+3309,AF3,7Z2O_IAJ,0.2727272727272727,0.8909090909090909,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+3310,AF3,7PRM_81I,0.26086956521739135,0.8956521739130434,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3311,AF3,8FLV_ZB9,0.04761904761904756,0.980952380952381,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3312,AF3,7NLV_UJE,0.19999999999999996,0.92,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+3313,AF3,7T0D_FPP,1.3846153846153846,0.4461538461538461,"{'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 5}"
+3314,AF3,7MWU_ZPM,0.125,0.95,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+3315,AF3,7L00_XCJ,0.09999999999999998,0.96,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3316,AF3,8C5M_MTA,1.0,0.6,{'UNL:LIG:VdWContact': 1},"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3317,AF3,7Z7F_IF3,0.06666666666666665,0.9733333333333334,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+3318,AF3,7TSF_H4B,0.1875,0.925,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+3319,AF3,7TUO_KL9,0.30434782608695643,0.8782608695652174,"{'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3320,AF3,7ED2_A3P,0.15,0.94,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+3321,AF3,7ZL5_IWE,0.3571428571428572,0.8571428571428571,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+3322,AF3,8F8E_XJI,0.0,1.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3323,AF3,7OZC_G6S,0.14285714285714282,0.9428571428571428,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+3324,AF3,7Q2B_M6H,0.1875,0.925,"{'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3325,AF3,6VTA_AKN,0.30000000000000004,0.88,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 4, 'UNL:GLU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+3326,AF3,7V3N_AKG,0.23529411764705885,0.9058823529411765,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3327,AF3,8F4J_PHO,,0.0,,
+3328,AF3,7ZOC_T8E,0.2666666666666666,0.8933333333333333,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+3329,AF3,7WCF_ACP,0.14814814814814808,0.9407407407407408,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+3330,AF3,7NUT_GLP,0.17647058823529416,0.9294117647058824,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1}"
+3331,AF3,7E4L_MDN,0.2000000000000001,0.9199999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+3332,AF3,7TS6_KMI,0.16666666666666669,0.9333333333333333,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3333,AF3,7NF3_4LU,0.06896551724137934,0.9724137931034482,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+3334,AF3,8D5D_5DK,0.13636363636363638,0.9454545454545454,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3335,AF3,7JMV_4NC,0.04761904761904756,0.980952380952381,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3336,AF3,7A9E_R4W,0.9090909090909092,0.6363636363636364,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+3337,AF3,7TBU_S3P,0.2666666666666667,0.8933333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+3338,AF3,7TB0_UD1,0.2173913043478261,0.9130434782608695,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+3339,AF3,7MFP_Z7P,0.25000000000000006,0.9,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 5, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+3340,AF3,6M2B_EZO,0.22222222222222215,0.9111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3341,AF3,7NPL_UKZ,0.4347826086956521,0.8260869565217391,"{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3342,AF3,7KZ9_XN7,0.24999999999999994,0.9,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+3343,AF3,7QE4_NGA,,0.0,,
+3344,AF3,8AP0_PRP,0.125,0.95,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+3345,AF3,7V3S_5I9,0.09523809523809523,0.9619047619047619,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+3346,AF3,7C0U_FGO,0.10000000000000003,0.96,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}"
+3347,AF3,7UXS_OJC,0.29999999999999993,0.88,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+3348,AF3,7X9K_8OG,0.09523809523809529,0.9619047619047619,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+3349,AF3,8BOM_QU6,0.07999999999999996,0.968,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3350,AF3,8BTI_RFO,0.17647058823529413,0.9294117647058824,"{'UNL:ALA:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3351,AF3,7RWS_4UR,0.2,0.92,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 3, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3352,AF3,6YQV_8K2,0.3333333333333333,0.8666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3353,AF3,7PK0_BYC,0.16666666666666663,0.9333333333333333,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3354,AF3,5SIS_JSM,0.1111111111111111,0.9555555555555556,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+3355,AF3,7NSW_HC4,0.04761904761904756,0.980952380952381,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3356,AF3,7F8T_FAD,0.18518518518518517,0.9259259259259259,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3357,AF3,5SD5_HWI,0.2777777777777778,0.8888888888888888,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+3358,AF3,7CUO_PHB,0.07692307692307698,0.9692307692307692,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+3359,AF3,7R3D_APR,0.2631578947368421,0.8947368421052632,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+3360,AF3,7WJB_BGC,0.2222222222222222,0.9111111111111111,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+3361,AF3,7A1P_QW2,0.20000000000000007,0.9199999999999999,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+3362,AF3,6ZPB_3D1,0.1875,0.925,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3363,AF3,7UTW_NAI,0.1304347826086956,0.9478260869565218,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+3364,AF3,7WUY_76N,1.1111111111111112,0.5555555555555556,{'UNL:MET:VdWContact': 1},"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3365,AF3,8A2D_KXY,0.18518518518518517,0.9259259259259259,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+3366,AF3,7NR8_UOE,,0.0,,
+3367,AF3,7KC5_BJZ,0.2857142857142857,0.8857142857142857,"{'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+3368,AF3,7QPP_VDX,0.1666666666666667,0.9333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+3369,AF3,7VKZ_NOJ,0.14285714285714282,0.9428571428571428,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+3370,AF3,7F51_BA7,0.22580645161290322,0.9096774193548387,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 2}"
+3371,AF3,7PL1_SFG,0.125,0.95,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+3372,AF3,7VB8_STL,,0.0,,
+3373,AF3,8FAV_4Y5,0.17391304347826078,0.9304347826086957,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3374,AF3,7CD9_FVR,0.3529411764705883,0.8588235294117647,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 6, 'UNL:TYR:VdWContact': 5}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}"
+3375,AF3,7N7H_CTP,0.04347826086956519,0.9826086956521739,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+3376,AF3,7ODY_DGI,0.2727272727272727,0.8909090909090909,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2}"
+3377,AF3,8CSD_C5P,0.46666666666666673,0.8133333333333332,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3378,AF3,7OFK_VCH,0.09523809523809512,0.9619047619047619,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+3379,AF3,7SDD_4IP,0.3846153846153847,0.8461538461538461,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 4, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+3380,AF3,7OPG_06N,0.26666666666666666,0.8933333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3}"
+3381,AF3,7ZTL_BCN,0.4285714285714286,0.8285714285714285,"{'UNL:PHE:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1}"
+3382,AF3,7SIU_9ID,0.5217391304347827,0.7913043478260869,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+3383,AF3,7LCU_XTA,0.5555555555555556,0.7777777777777778,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3384,AF3,7NGW_UAW,0.38888888888888895,0.8444444444444444,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+3385,AF3,7VYJ_CA0,1.0,0.6,"{'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+3386,AF3,7QHG_T3B,0.17241379310344834,0.9310344827586207,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+3387,AF3,8HO0_3ZI,0.16666666666666657,0.9333333333333333,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
diff --git a/notebooks/posebusters_benchmark_plif_wm_values.png b/notebooks/posebusters_benchmark_plif_wm_values.png
new file mode 100644
index 00000000..b1e1da57
Binary files /dev/null and b/notebooks/posebusters_benchmark_plif_wm_values.png differ
diff --git a/notebooks/posebusters_benchmark_primary_ligand_relaxed_bar_chart.png b/notebooks/posebusters_benchmark_primary_ligand_relaxed_bar_chart.png
new file mode 100644
index 00000000..55935f32
Binary files /dev/null and b/notebooks/posebusters_benchmark_primary_ligand_relaxed_bar_chart.png differ
diff --git a/notebooks/posebusters_benchmark_primary_ligand_relaxed_rmsd_violin_plot.png b/notebooks/posebusters_benchmark_primary_ligand_relaxed_rmsd_violin_plot.png
new file mode 100644
index 00000000..71d6c435
Binary files /dev/null and b/notebooks/posebusters_benchmark_primary_ligand_relaxed_rmsd_violin_plot.png differ
diff --git a/notebooks/posebusters_benchmark_structured_plif_metrics.csv b/notebooks/posebusters_benchmark_structured_plif_metrics.csv
new file mode 100644
index 00000000..574aaeef
--- /dev/null
+++ b/notebooks/posebusters_benchmark_structured_plif_metrics.csv
@@ -0,0 +1,849 @@
+,Category,Target,Structured_EMD,Unstructured_EMD,Method_Histogram,Reference_Histogram
+0,P2Rank-Vina,7UAW_MF6,1.0,0.6153846153846152,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+1,P2Rank-Vina,8D19_GSH,0.75,0.4545454545454545,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+2,P2Rank-Vina,8C3N_ADP,0.22222222222222227,0.06666666666666665,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+3,P2Rank-Vina,7XQZ_FPF,0.5,0.16666666666666674,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+4,P2Rank-Vina,7R59_I5F,0.3333333333333333,0.09999999999999998,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+5,P2Rank-Vina,7XBV_APC,0.8,0.5,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+6,P2Rank-Vina,7ZDY_6MJ,0.0,0.5714285714285714,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+7,P2Rank-Vina,7THI_PGA,0.4999999999999999,0.25,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+8,P2Rank-Vina,7TE8_P0T,0.0,0.3809523809523811,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 3, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+9,P2Rank-Vina,7QF4_RBF,1.25,0.2941176470588236,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+10,P2Rank-Vina,7YZU_DO7,0.0,0.4166666666666667,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+11,P2Rank-Vina,8B8H_OJQ,0.11111111111111116,0.09090909090909094,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+12,P2Rank-Vina,7WKL_CAQ,0.3333333333333333,0.46153846153846145,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 3, 'UNL:ASN:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+13,P2Rank-Vina,7SZA_DUI,0.75,0.06666666666666665,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+14,P2Rank-Vina,7T3E_SLB,0.7142857142857143,0.7000000000000001,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+15,P2Rank-Vina,8G0V_YHT,0.6666666666666667,0.25,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+16,P2Rank-Vina,8HFN_XGC,0.6666666666666667,0.39999999999999997,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+17,P2Rank-Vina,7W06_ITN,0.8333333333333334,0.29999999999999993,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+18,P2Rank-Vina,8GFD_ZHR,0.3333333333333333,0.19999999999999996,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+19,P2Rank-Vina,7UQ3_O2U,0.5,0.7142857142857143,"{'UNL:GLU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+20,P2Rank-Vina,7XG5_PLP,0.8,0.45454545454545453,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+21,P2Rank-Vina,7WUX_6OI,1.0,0.4545454545454545,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}"
+22,P2Rank-Vina,7ULC_56B,0.5,0.5263157894736842,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+23,P2Rank-Vina,7SFO_98L,0.3333333333333333,0.6190476190476193,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+24,P2Rank-Vina,7XFA_D9J,0.0,0.18181818181818177,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+25,P2Rank-Vina,7WDT_NGS,0.0,0.4285714285714286,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+26,P2Rank-Vina,7W05_GMP,0.5,0.4444444444444445,"{'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+27,P2Rank-Vina,7WQQ_5Z6,0.0,0.6428571428571428,"{'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 4, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+28,P2Rank-Vina,7WL4_JFU,0.0,0.10526315789473684,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+29,P2Rank-Vina,7Z2O_IAJ,0.0,0.2941176470588236,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+30,P2Rank-Vina,7TUO_KL9,0.3333333333333333,0.16666666666666674,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+31,P2Rank-Vina,8F8E_XJI,0.3333333333333333,0.3684210526315789,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+32,P2Rank-Vina,7Q2B_M6H,0.0,0.1818181818181817,"{'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+33,P2Rank-Vina,7ZOC_T8E,0.3333333333333333,0.21428571428571425,"{'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+34,P2Rank-Vina,7WCF_ACP,0.6,0.3157894736842106,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+35,P2Rank-Vina,7TBU_S3P,0.5999999999999999,0.25,"{'UNL:ARG:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+36,P2Rank-Vina,8BOM_QU6,0.75,0.33333333333333337,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+37,P2Rank-Vina,5SIS_JSM,0.0,0.28571428571428575,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+38,P2Rank-Vina,7R3D_APR,0.5,0.588235294117647,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+39,P2Rank-Vina,7QPP_VDX,0.25,0.41176470588235303,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+40,P2Rank-Vina,7VKZ_NOJ,0.6666666666666667,0.2727272727272726,"{'UNL:ASP:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+41,P2Rank-Vina,7SIU_9ID,0.19999999999999996,0.3333333333333333,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+42,DiffDock-L,8AAU_LH0,0.5,0.5294117647058824,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+43,DiffDock-L,7UAW_MF6,0.875,0.5555555555555556,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+44,DiffDock-L,7UJ5_DGL,0.8571428571428572,0.1538461538461538,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+45,DiffDock-L,8EX2_Q2Q,0.0,0.16666666666666669,"{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+46,DiffDock-L,7UYB_OK0,0.5,0.07692307692307698,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+47,DiffDock-L,7U0U_FK5,0.0,0.22580645161290325,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+48,DiffDock-L,8D19_GSH,0.75,0.16666666666666666,"{'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+49,DiffDock-L,8C3N_ADP,0.4285714285714286,0.44444444444444436,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+50,DiffDock-L,8A1H_DLZ,0.16666666666666666,0.1875,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+51,DiffDock-L,7XQZ_FPF,0.25,0.1666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+52,DiffDock-L,7R59_I5F,0.5,0.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+53,DiffDock-L,7ZCC_OGA,0.5,0.1428571428571429,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+54,DiffDock-L,7QFM_AY3,0.6666666666666667,0.26666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+55,DiffDock-L,7QTA_URI,0.6666666666666667,0.3999999999999999,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+56,DiffDock-L,7XBV_APC,0.0,0.15384615384615374,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+57,DiffDock-L,7ZDY_6MJ,0.6666666666666666,0.28571428571428575,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+58,DiffDock-L,7V14_ORU,0.0,0.26666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+59,DiffDock-L,7Q27_8KC,0.75,0.2666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 3, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+60,DiffDock-L,7THI_PGA,1.0,0.6666666666666666,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+61,DiffDock-L,7XPO_UPG,0.0,0.08333333333333337,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+62,DiffDock-L,7TE8_P0T,0.3333333333333333,0.49999999999999983,"{'UNL:ALA:Hydrophobic': 5, 'UNL:ALA:VdWContact': 3, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+63,DiffDock-L,7QF4_RBF,0.5,0.25,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+64,DiffDock-L,7UJ4_OQ4,0.3333333333333333,0.4090909090909091,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+65,DiffDock-L,8EAB_VN2,0.6666666666666667,0.75,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+66,DiffDock-L,7TH4_FFO,0.1428571428571429,0.411764705882353,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+67,DiffDock-L,7YZU_DO7,0.14285714285714285,0.5000000000000001,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+68,DiffDock-L,8B8H_OJQ,0.22222222222222215,0.0625,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+69,DiffDock-L,7TOM_5AD,0.39999999999999997,0.19999999999999996,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+70,DiffDock-L,7XI7_4RI,0.0,0.10000000000000009,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+71,DiffDock-L,7WKL_CAQ,0.3333333333333333,0.23076923076923073,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+72,DiffDock-L,7WPW_F15,0.3333333333333333,0.3125,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+73,DiffDock-L,8SLG_G5A,0.25,0.3636363636363637,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+74,DiffDock-L,7SZA_DUI,0.3333333333333333,0.1111111111111111,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+75,DiffDock-L,7T3E_SLB,0.8333333333333333,0.9,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+76,DiffDock-L,8CNH_V6U,0.3333333333333333,0.5333333333333332,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 5, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+77,DiffDock-L,8G0V_YHT,0.2,0.4,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+78,DiffDock-L,7Z1Q_NIO,0.0,0.41666666666666674,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+79,DiffDock-L,7X5N_5M5,0.6666666666666666,0.2142857142857143,"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+80,DiffDock-L,7VQ9_ISY,0.5,0.1333333333333333,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+81,DiffDock-L,8AQL_PLG,0.16666666666666674,0.2727272727272727,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+82,DiffDock-L,7TYP_KUR,0.0,0.6086956521739131,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+83,DiffDock-L,8HFN_XGC,0.7999999999999999,0.44444444444444453,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 3, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+84,DiffDock-L,7W06_ITN,0.8333333333333334,0.18181818181818177,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+85,DiffDock-L,7UQ3_O2U,0.25,0.08333333333333333,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+86,DiffDock-L,7USH_82V,0.0,0.16666666666666669,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+87,DiffDock-L,7XG5_PLP,0.5999999999999999,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+88,DiffDock-L,7WUX_6OI,0.22222222222222227,0.4444444444444445,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}"
+89,DiffDock-L,7QHL_D5P,0.0,0.16666666666666669,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+90,DiffDock-L,7Q5I_I0F,0.16666666666666666,0.09090909090909094,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+91,DiffDock-L,8DKO_TFB,0.6666666666666667,0.2727272727272727,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+92,DiffDock-L,8G6P_API,0.75,0.2727272727272726,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+93,DiffDock-L,7ULC_56B,0.8333333333333334,0.33333333333333326,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+94,DiffDock-L,8DP2_UMA,0.625,0.1333333333333333,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+95,DiffDock-L,7XFA_D9J,0.0,0.4000000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+96,DiffDock-L,7WDT_NGS,0.5,0.6,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+97,DiffDock-L,8AEM_LVF,0.0,0.30000000000000004,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+98,DiffDock-L,7ZHP_IQY,0.0,0.24999999999999997,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+99,DiffDock-L,7W05_GMP,0.4,0.6666666666666666,"{'UNL:ASN:HBDonor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+100,DiffDock-L,8AIE_M7L,0.6,0.14285714285714282,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 4, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 4, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+101,DiffDock-L,8EYE_X4I,0.6,0.125,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+102,DiffDock-L,7UY4_SMI,0.0,0.33333333333333337,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+103,DiffDock-L,7UMW_NAD,0.33333333333333337,0.04999999999999999,"{'UNL:ALA:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+104,DiffDock-L,7U3J_L6U,0.3333333333333333,0.30000000000000004,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+105,DiffDock-L,7QGP_DJ8,0.5,0.3,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+106,DiffDock-L,7TM6_GPJ,0.5714285714285714,0.42857142857142855,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+107,DiffDock-L,7WQQ_5Z6,0.5,0.375,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+108,DiffDock-L,7WL4_JFU,0.0,0.16666666666666657,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+109,DiffDock-L,7Z2O_IAJ,0.0,0.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+110,DiffDock-L,8FLV_ZB9,0.3333333333333333,0.21739130434782614,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+111,DiffDock-L,7T0D_FPP,0.25,0.18181818181818185,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 5}"
+112,DiffDock-L,8C5M_MTA,0.3333333333333333,0.4166666666666667,"{'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+113,DiffDock-L,7Z7F_IF3,0.0,0.2000000000000001,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+114,DiffDock-L,7ZL5_IWE,0.0,0.6363636363636362,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+115,DiffDock-L,7ZOC_T8E,0.5,0.27272727272727276,"{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+116,DiffDock-L,7WCF_ACP,0.16666666666666666,0.1578947368421053,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+117,DiffDock-L,8D5D_5DK,0.16666666666666663,0.23529411764705885,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+118,DiffDock-L,7TBU_S3P,0.5999999999999999,0.375,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+119,DiffDock-L,7TB0_UD1,0.42857142857142855,0.375,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+120,DiffDock-L,7QE4_NGA,0.5,0.6000000000000001,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+121,DiffDock-L,8AP0_PRP,1.1428571428571428,0.4285714285714286,"{'UNL:ARG:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+122,DiffDock-L,8BOM_QU6,0.5,0.1428571428571429,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+123,DiffDock-L,5SIS_JSM,0.6666666666666666,0.14999999999999997,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+124,DiffDock-L,5SD5_HWI,0.75,0.375,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+125,DiffDock-L,7R3D_APR,0.14285714285714285,0.1538461538461538,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:HBDonor': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+126,DiffDock-L,7WJB_BGC,0.0,0.25,"{'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+127,DiffDock-L,7UTW_NAI,0.2857142857142857,0.3125,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+128,DiffDock-L,7QPP_VDX,0.25,0.3529411764705883,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+129,DiffDock-L,7VKZ_NOJ,0.6,0.125,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+130,DiffDock-L,8FAV_4Y5,0.6000000000000001,0.24999999999999994,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+131,DiffDock-L,8CSD_C5P,0.7999999999999999,0.3,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+132,DiffDock-L,7SIU_9ID,0.2,0.4761904761904761,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+133,DiffDock-L,7VYJ_CA0,0.5,0.15384615384615385,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+134,DiffDock-L,7QHG_T3B,0.4,0.12499999999999997,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+135,DynamicBind,7UJ5_DGL,0.8571428571428571,0.6363636363636364,"{'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+136,DynamicBind,8EX2_Q2Q,0.0,0.41666666666666663,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+137,DynamicBind,8C3N_ADP,0.625,0.3333333333333333,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 4, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+138,DynamicBind,7R59_I5F,0.0,0.3333333333333333,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+139,DynamicBind,7V14_ORU,0.0,0.3333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+140,DynamicBind,7Q27_8KC,0.5999999999999999,0.3999999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+141,DynamicBind,8DHG_T78,0.6666666666666667,0.4814814814814814,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+142,DynamicBind,8EXL_799,0.25,0.3684210526315789,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+143,DynamicBind,7THI_PGA,1.2,0.5714285714285715,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+144,DynamicBind,7XPO_UPG,0.9999999999999999,0.06666666666666665,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+145,DynamicBind,7TE8_P0T,0.3333333333333333,0.25000000000000006,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+146,DynamicBind,7QF4_RBF,1.25,0.375,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+147,DynamicBind,7UJ4_OQ4,0.0,0.27272727272727276,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+148,DynamicBind,7YZU_DO7,0.5,0.5,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+149,DynamicBind,8B8H_OJQ,0.75,0.3333333333333332,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+150,DynamicBind,7TOM_5AD,0.49999999999999994,0.0434782608695653,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+151,DynamicBind,7VWF_K55,0.0,0.5454545454545455,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+152,DynamicBind,7XI7_4RI,0.0,0.25000000000000006,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+153,DynamicBind,7WKL_CAQ,0.0,0.23076923076923078,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+154,DynamicBind,7WPW_F15,0.3333333333333333,0.1875,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+155,DynamicBind,8SLG_G5A,0.125,0.4545454545454546,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 4, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+156,DynamicBind,7SZA_DUI,0.75,0.3076923076923077,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+157,DynamicBind,7ZF0_DHR,0.0,0.3,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3}"
+158,DynamicBind,7XRL_FWK,0.6666666666666666,0.5294117647058824,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+159,DynamicBind,7X5N_5M5,0.16666666666666669,0.2222222222222223,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+160,DynamicBind,7VQ9_ISY,0.25,0.3333333333333333,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+161,DynamicBind,8AQL_PLG,0.16666666666666666,0.41666666666666663,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+162,DynamicBind,7TYP_KUR,0.0,0.5384615384615383,"{'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+163,DynamicBind,7XJN_NSD,0.3333333333333333,1.125,"{'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+164,DynamicBind,8HFN_XGC,0.2857142857142857,0.19047619047619047,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+165,DynamicBind,7W06_ITN,1.0,0.41666666666666663,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+166,DynamicBind,8GFD_ZHR,0.0,0.4000000000000001,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+167,DynamicBind,7UQ3_O2U,0.6666666666666666,0.08333333333333326,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+168,DynamicBind,7USH_82V,0.0,0.16666666666666669,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+169,DynamicBind,7XG5_PLP,1.0,0.30769230769230765,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+170,DynamicBind,7QHL_D5P,0.0,0.05882352941176472,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+171,DynamicBind,8G6P_API,0.625,0.09090909090909088,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+172,DynamicBind,7ULC_56B,0.8333333333333334,0.3333333333333335,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+173,DynamicBind,8DP2_UMA,0.5555555555555556,0.4736842105263159,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+174,DynamicBind,7ZZW_KKW,0.0,0.4375,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+175,DynamicBind,7XFA_D9J,0.0,0.1111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+176,DynamicBind,7WDT_NGS,0.6000000000000001,0.8888888888888888,"{'UNL:GLU:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+177,DynamicBind,8AEM_LVF,0.0,0.38461538461538464,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+178,DynamicBind,7ZHP_IQY,0.3333333333333333,0.4210526315789474,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+179,DynamicBind,8AIE_M7L,1.2,0.3999999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+180,DynamicBind,8EYE_X4I,1.0,0.23529411764705888,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+181,DynamicBind,7UMW_NAD,0.5714285714285714,0.5238095238095237,"{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+182,DynamicBind,7TM6_GPJ,0.8333333333333333,0.6666666666666665,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LYS:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+183,DynamicBind,7WQQ_5Z6,0.0,0.625,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+184,DynamicBind,7WL4_JFU,0.0,0.33333333333333326,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+185,DynamicBind,7Z2O_IAJ,0.5,0.29999999999999993,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+186,DynamicBind,7Z7F_IF3,0.0,0.18181818181818185,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+187,DynamicBind,7ZL5_IWE,0.5,0.6923076923076923,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+188,DynamicBind,7ZOC_T8E,0.0,0.30769230769230765,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+189,DynamicBind,7WCF_ACP,0.2857142857142857,0.09523809523809518,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+190,DynamicBind,8D5D_5DK,1.1666666666666665,0.19047619047619052,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+191,DynamicBind,7TBU_S3P,0.39999999999999997,0.49999999999999994,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+192,DynamicBind,8BOM_QU6,0.75,0.09090909090909094,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+193,DynamicBind,5SIS_JSM,0.5,0.2222222222222222,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+194,DynamicBind,5SD5_HWI,1.0,0.3529411764705883,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+195,DynamicBind,7WJB_BGC,0.5,0.42857142857142855,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+196,DynamicBind,7UTW_NAI,0.22222222222222215,0.38888888888888895,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+197,DynamicBind,7QPP_VDX,0.5,0.5,"{'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+198,DynamicBind,7VKZ_NOJ,0.6,0.42857142857142866,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+199,DynamicBind,8CSD_C5P,0.5,0.75,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+200,DynamicBind,7SIU_9ID,0.3333333333333333,0.17647058823529416,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+201,DynamicBind,7QHG_T3B,0.6,0.409090909090909,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+202,NeuralPLexer,7UAW_MF6,0.7777777777777779,0.29411764705882343,"{'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+203,NeuralPLexer,7UJ5_DGL,0.25,0.08333333333333334,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+204,NeuralPLexer,7UYB_OK0,0.39999999999999997,0.2857142857142858,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+205,NeuralPLexer,8D19_GSH,0.39999999999999997,0.24999999999999994,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+206,NeuralPLexer,8C3N_ADP,0.625,0.44444444444444436,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+207,NeuralPLexer,7XQZ_FPF,0.75,0.2222222222222223,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+208,NeuralPLexer,7XBV_APC,0.5,0.21428571428571422,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+209,NeuralPLexer,7ZDY_6MJ,0.0,0.14285714285714285,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+210,NeuralPLexer,7Q27_8KC,0.8,0.4736842105263158,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+211,NeuralPLexer,7THI_PGA,1.2,0.7142857142857144,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+212,NeuralPLexer,7QF4_RBF,0.75,0.375,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+213,NeuralPLexer,8EAB_VN2,0.6666666666666667,0.8333333333333335,"{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 7, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+214,NeuralPLexer,8D39_QDB,0.0,0.2727272727272727,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+215,NeuralPLexer,7YZU_DO7,0.5,0.3571428571428571,"{'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+216,NeuralPLexer,8B8H_OJQ,0.5,0.2,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+217,NeuralPLexer,7TOM_5AD,0.8,0.5555555555555557,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+218,NeuralPLexer,7XI7_4RI,0.5,0.08333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+219,NeuralPLexer,7WKL_CAQ,0.3333333333333333,0.08333333333333334,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+220,NeuralPLexer,7WPW_F15,0.3333333333333333,0.33333333333333337,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+221,NeuralPLexer,8SLG_G5A,1.0,0.45454545454545453,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+222,NeuralPLexer,7T3E_SLB,1.0,0.875,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+223,NeuralPLexer,8CNH_V6U,0.6000000000000001,0.4285714285714286,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+224,NeuralPLexer,8G0V_YHT,0.0,0.4117647058823529,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+225,NeuralPLexer,7X5N_5M5,0.19999999999999996,0.1578947368421052,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+226,NeuralPLexer,7VQ9_ISY,1.0,0.7692307692307693,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+227,NeuralPLexer,8AQL_PLG,0.1428571428571429,0.08333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+228,NeuralPLexer,7XJN_NSD,0.0,1.25,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+229,NeuralPLexer,8AUH_L9I,0.6666666666666667,0.3333333333333333,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+230,NeuralPLexer,7W06_ITN,1.0,0.2222222222222222,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+231,NeuralPLexer,7UAS_MBU,0.0,0.27777777777777773,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+232,NeuralPLexer,7UQ3_O2U,0.3333333333333333,0.5454545454545454,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+233,NeuralPLexer,7XG5_PLP,0.75,0.3846153846153846,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+234,NeuralPLexer,7QHL_D5P,0.0,0.42105263157894746,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 3, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+235,NeuralPLexer,7Q5I_I0F,0.375,0.35294117647058826,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+236,NeuralPLexer,8DKO_TFB,0.6666666666666667,0.375,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+237,NeuralPLexer,8G6P_API,1.0,0.22222222222222215,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+238,NeuralPLexer,7ULC_56B,0.125,0.3571428571428572,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+239,NeuralPLexer,8DP2_UMA,0.39999999999999997,0.19999999999999998,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+240,NeuralPLexer,7WY1_D0L,0.6000000000000001,0.3500000000000001,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+241,NeuralPLexer,7ZHP_IQY,0.3333333333333333,0.2727272727272727,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+242,NeuralPLexer,7W05_GMP,1.0,0.75,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+243,NeuralPLexer,8AIE_M7L,1.5,0.15384615384615374,"{'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+244,NeuralPLexer,7UY4_SMI,0.0,0.5,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+245,NeuralPLexer,7UMW_NAD,0.5,0.13636363636363635,"{'UNL:ALA:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+246,NeuralPLexer,7TM6_GPJ,1.0,0.7142857142857143,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+247,NeuralPLexer,7WQQ_5Z6,0.5,0.33333333333333326,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+248,NeuralPLexer,7WL4_JFU,0.0,0.1578947368421053,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+249,NeuralPLexer,8FLV_ZB9,0.3333333333333333,0.1999999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+250,NeuralPLexer,8C5M_MTA,0.19999999999999996,0.07692307692307693,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+251,NeuralPLexer,7TUO_KL9,0.0,0.1250000000000001,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+252,NeuralPLexer,7ZL5_IWE,0.3333333333333333,0.5384615384615384,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+253,NeuralPLexer,8F8E_XJI,0.3333333333333333,0.25000000000000006,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+254,NeuralPLexer,7WCF_ACP,0.125,0.25,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+255,NeuralPLexer,8D5D_5DK,0.7142857142857143,0.375,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+256,NeuralPLexer,7TBU_S3P,0.49999999999999994,0.5,"{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+257,NeuralPLexer,7TB0_UD1,0.625,0.19999999999999996,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+258,NeuralPLexer,8AP0_PRP,1.0,0.25,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+259,NeuralPLexer,7UXS_OJC,0.6666666666666666,0.2666666666666666,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+260,NeuralPLexer,7X9K_8OG,0.875,0.1333333333333333,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+261,NeuralPLexer,5SIS_JSM,0.0,0.10526315789473684,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+262,NeuralPLexer,7R3D_APR,0.16666666666666666,0.3333333333333334,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+263,NeuralPLexer,7WJB_BGC,0.25,0.33333333333333337,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+264,NeuralPLexer,7UTW_NAI,0.5,0.3157894736842106,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 5, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+265,NeuralPLexer,7QPP_VDX,1.0,0.3529411764705883,"{'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+266,NeuralPLexer,7VKZ_NOJ,0.8,0.5,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+267,NeuralPLexer,8CSD_C5P,0.25,0.7000000000000001,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+268,NeuralPLexer,7VYJ_CA0,0.6666666666666666,0.23529411764705885,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+269,RFAA,8EX2_Q2Q,0.0,0.1666666666666667,"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+270,RFAA,7U0U_FK5,0.5,0.22222222222222227,"{'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 4, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+271,RFAA,8C3N_ADP,0.4285714285714286,0.5555555555555555,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+272,RFAA,7R59_I5F,0.0,0.33333333333333326,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+273,RFAA,7TOM_5AD,0.19999999999999996,0.4117647058823529,"{'UNL:GLN:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+274,RFAA,7XI7_4RI,0.3333333333333333,0.08333333333333331,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+275,RFAA,8HFN_XGC,0.5,0.368421052631579,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+276,RFAA,7ULC_56B,0.8333333333333334,0.6153846153846152,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 5, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+277,RFAA,7UY4_SMI,0.0,0.4999999999999999,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 5, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+278,RFAA,7UMW_NAD,0.5714285714285714,0.6190476190476191,"{'UNL:ALA:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 5, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+279,RFAA,8FLV_ZB9,0.3333333333333333,0.26315789473684204,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+280,RFAA,8C5M_MTA,0.3333333333333333,0.26666666666666666,"{'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+281,RFAA,8F8E_XJI,0.39999999999999997,0.5263157894736843,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+282,RFAA,5SIS_JSM,0.0,0.2727272727272727,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+283,RFAA,7WJB_BGC,0.6666666666666666,0.4285714285714285,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 4, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+284,RFAA,7QPP_VDX,0.19999999999999996,0.9375,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+285,Chai-1-Single-Seq,8AAU_LH0,0.0,0.25000000000000006,"{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+286,Chai-1-Single-Seq,7UAW_MF6,0.75,0.29411764705882343,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+287,Chai-1-Single-Seq,7UJ5_DGL,0.28571428571428575,0.0,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+288,Chai-1-Single-Seq,8EX2_Q2Q,0.0,0.33333333333333337,"{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+289,Chai-1-Single-Seq,7UYB_OK0,0.0,0.23076923076923084,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+290,Chai-1-Single-Seq,7U0U_FK5,0.5,0.4,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+291,Chai-1-Single-Seq,8D19_GSH,0.2,0.125,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+292,Chai-1-Single-Seq,8C3N_ADP,0.14285714285714285,0.2000000000000001,"{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+293,Chai-1-Single-Seq,8A1H_DLZ,0.16666666666666666,0.3571428571428571,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+294,Chai-1-Single-Seq,7XQZ_FPF,0.39999999999999997,0.21052631578947367,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+295,Chai-1-Single-Seq,7TXK_LW8,0.5,0.0625,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+296,Chai-1-Single-Seq,7R59_I5F,0.5,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+297,Chai-1-Single-Seq,7ZCC_OGA,0.5,0.7142857142857143,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+298,Chai-1-Single-Seq,7QFM_AY3,0.5,0.1666666666666667,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+299,Chai-1-Single-Seq,7QTA_URI,0.5,0.08333333333333331,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+300,Chai-1-Single-Seq,7XBV_APC,0.16666666666666666,0.23076923076923073,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+301,Chai-1-Single-Seq,7V14_ORU,0.0,0.14285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+302,Chai-1-Single-Seq,7Q27_8KC,0.25,0.21428571428571425,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+303,Chai-1-Single-Seq,8DHG_T78,0.3333333333333333,0.22222222222222227,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 5, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+304,Chai-1-Single-Seq,8EXL_799,0.25,0.23809523809523808,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+305,Chai-1-Single-Seq,7THI_PGA,0.5,0.16666666666666666,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+306,Chai-1-Single-Seq,7XPO_UPG,0.125,0.2727272727272728,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+307,Chai-1-Single-Seq,7TE8_P0T,0.0,0.5789473684210528,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+308,Chai-1-Single-Seq,7QF4_RBF,0.25,0.1875,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 4, 'UNL:GLN:HBAcceptor': 3, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+309,Chai-1-Single-Seq,7UJ4_OQ4,0.0,0.11111111111111113,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+310,Chai-1-Single-Seq,8EAB_VN2,1.0,0.4615384615384615,"{'UNL:ASP:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+311,Chai-1-Single-Seq,7Q25_8J9,1.25,0.19999999999999996,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 3, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+312,Chai-1-Single-Seq,7TH4_FFO,0.39999999999999997,0.375,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+313,Chai-1-Single-Seq,8D39_QDB,0.0,0.09999999999999998,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+314,Chai-1-Single-Seq,7YZU_DO7,0.28571428571428575,0.23076923076923073,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+315,Chai-1-Single-Seq,8B8H_OJQ,0.0,0.11111111111111113,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+316,Chai-1-Single-Seq,7TOM_5AD,0.16666666666666663,0.5,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+317,Chai-1-Single-Seq,7VWF_K55,1.0,0.12500000000000006,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+318,Chai-1-Single-Seq,7XI7_4RI,0.3333333333333333,0.30000000000000004,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+319,Chai-1-Single-Seq,7WPW_F15,0.5,0.2666666666666668,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+320,Chai-1-Single-Seq,8SLG_G5A,0.42857142857142866,0.3333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+321,Chai-1-Single-Seq,7SZA_DUI,0.3333333333333333,0.23529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+322,Chai-1-Single-Seq,7T3E_SLB,0.6666666666666666,0.2222222222222222,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+323,Chai-1-Single-Seq,7X5N_5M5,0.6666666666666666,0.06666666666666667,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+324,Chai-1-Single-Seq,7VQ9_ISY,0.6666666666666667,0.41666666666666674,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+325,Chai-1-Single-Seq,7XJN_NSD,0.5,0.875,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+326,Chai-1-Single-Seq,8HFN_XGC,0.6,0.11111111111111102,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+327,Chai-1-Single-Seq,8AUH_L9I,0.6666666666666667,0.5,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+328,Chai-1-Single-Seq,7W06_ITN,0.6666666666666667,0.33333333333333326,"{'UNL:ALA:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+329,Chai-1-Single-Seq,7UAS_MBU,0.0,0.4375,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+330,Chai-1-Single-Seq,8GFD_ZHR,0.0,0.0714285714285714,"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+331,Chai-1-Single-Seq,7UQ3_O2U,0.25,0.08333333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+332,Chai-1-Single-Seq,7USH_82V,0.5,0.18181818181818185,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+333,Chai-1-Single-Seq,7XG5_PLP,0.0,0.18181818181818185,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+334,Chai-1-Single-Seq,7WUX_6OI,0.4444444444444445,0.5714285714285714,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}"
+335,Chai-1-Single-Seq,7QHL_D5P,0.0,0.0,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+336,Chai-1-Single-Seq,7Q5I_I0F,0.7142857142857142,0.2666666666666666,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+337,Chai-1-Single-Seq,8DKO_TFB,0.33333333333333337,0.33333333333333337,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+338,Chai-1-Single-Seq,7ULC_56B,0.4,0.19999999999999996,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+339,Chai-1-Single-Seq,7SFO_98L,0.0,0.2941176470588236,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+340,Chai-1-Single-Seq,8DP2_UMA,0.3333333333333333,0.14285714285714285,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+341,Chai-1-Single-Seq,7XFA_D9J,0.0,0.2,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+342,Chai-1-Single-Seq,7WDT_NGS,0.25,0.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+343,Chai-1-Single-Seq,7WY1_D0L,0.0,0.3157894736842105,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+344,Chai-1-Single-Seq,7ZHP_IQY,0.6666666666666666,0.36842105263157904,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+345,Chai-1-Single-Seq,7W05_GMP,0.0,0.125,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+346,Chai-1-Single-Seq,7UJF_R3V,0.5,0.21052631578947367,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+347,Chai-1-Single-Seq,8AIE_M7L,1.0,0.33333333333333337,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:VdWContact': 5, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+348,Chai-1-Single-Seq,8EYE_X4I,0.16666666666666663,0.17647058823529405,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+349,Chai-1-Single-Seq,7UMW_NAD,0.33333333333333337,0.11111111111111113,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+350,Chai-1-Single-Seq,7U3J_L6U,0.5,0.09090909090909086,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+351,Chai-1-Single-Seq,7QGP_DJ8,0.5,0.19999999999999996,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+352,Chai-1-Single-Seq,7TM6_GPJ,0.14285714285714285,0.0,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+353,Chai-1-Single-Seq,7WQQ_5Z6,0.5,0.5714285714285714,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+354,Chai-1-Single-Seq,7WL4_JFU,0.0,0.1666666666666666,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+355,Chai-1-Single-Seq,7Z2O_IAJ,0.0,0.08333333333333326,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+356,Chai-1-Single-Seq,7T0D_FPP,0.2,0.29999999999999993,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 5}"
+357,Chai-1-Single-Seq,8C5M_MTA,0.3333333333333333,0.33333333333333337,"{'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+358,Chai-1-Single-Seq,7Z7F_IF3,0.5,0.18181818181818182,"{'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+359,Chai-1-Single-Seq,7TSF_H4B,0.75,0.5714285714285714,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+360,Chai-1-Single-Seq,7TUO_KL9,0.5,0.5909090909090909,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+361,Chai-1-Single-Seq,7Q2B_M6H,0.0,0.4666666666666668,"{'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+362,Chai-1-Single-Seq,7WCF_ACP,0.14285714285714285,0.058823529411764705,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+363,Chai-1-Single-Seq,7TS6_KMI,0.3333333333333333,0.6,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+364,Chai-1-Single-Seq,8D5D_5DK,0.39999999999999997,0.125,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+365,Chai-1-Single-Seq,7TBU_S3P,0.2,0.5,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+366,Chai-1-Single-Seq,8AP0_PRP,0.09090909090909094,0.33333333333333337,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 4, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+367,Chai-1-Single-Seq,7UXS_OJC,0.6,0.35714285714285715,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+368,Chai-1-Single-Seq,7X9K_8OG,0.2222222222222222,0.07692307692307687,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+369,Chai-1-Single-Seq,8BOM_QU6,0.0,0.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+370,Chai-1-Single-Seq,5SIS_JSM,0.0,0.2777777777777778,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+371,Chai-1-Single-Seq,5SD5_HWI,0.5,0.3076923076923078,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+372,Chai-1-Single-Seq,7R3D_APR,0.2,0.5833333333333334,"{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 5}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+373,Chai-1-Single-Seq,7WJB_BGC,0.0,0.16666666666666674,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+374,Chai-1-Single-Seq,7UTW_NAI,0.30000000000000004,0.1875,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+375,Chai-1-Single-Seq,7QPP_VDX,0.33333333333333337,0.33333333333333326,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 4, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+376,Chai-1-Single-Seq,8CSD_C5P,0.2,0.2727272727272727,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+377,Chai-1-Single-Seq,7SIU_9ID,0.0,0.3500000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+378,Chai-1-Single-Seq,7VYJ_CA0,0.1428571428571429,0.25,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+379,Chai-1-Single-Seq,7QHG_T3B,0.4,0.5909090909090908,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+380,Chai-1-Single-Seq,8HO0_3ZI,0.5,0.1538461538461538,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+381,Chai-1,8AAU_LH0,0.0,0.2857142857142857,"{'UNL:ALA:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+382,Chai-1,7UAW_MF6,0.5,0.2727272727272728,"{'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+383,Chai-1,7UJ5_DGL,0.4285714285714286,0.1538461538461539,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+384,Chai-1,8EX2_Q2Q,0.0,0.33333333333333337,"{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+385,Chai-1,7UYB_OK0,0.0,0.14285714285714293,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+386,Chai-1,7U0U_FK5,0.0,0.3600000000000001,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+387,Chai-1,8D19_GSH,0.2,0.5,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+388,Chai-1,8C3N_ADP,0.1111111111111111,0.10000000000000009,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+389,Chai-1,8A1H_DLZ,0.0,0.13333333333333336,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+390,Chai-1,7XQZ_FPF,0.25,0.22222222222222218,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+391,Chai-1,7R59_I5F,0.5,0.3333333333333333,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+392,Chai-1,7ZCC_OGA,0.5,0.8571428571428571,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+393,Chai-1,7QFM_AY3,0.5,0.21428571428571427,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+394,Chai-1,7QTA_URI,0.0,0.28571428571428575,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+395,Chai-1,8DSC_NCA,0.0,0.3333333333333333,"{'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+396,Chai-1,7XBV_APC,0.4,0.30769230769230765,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+397,Chai-1,7V14_ORU,0.0,0.26666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+398,Chai-1,7Q27_8KC,0.5,0.4285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+399,Chai-1,8DHG_T78,0.0,0.2222222222222223,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 5, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+400,Chai-1,8EXL_799,0.25,0.05263157894736842,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+401,Chai-1,7THI_PGA,0.16666666666666674,0.16666666666666663,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+402,Chai-1,7XPO_UPG,0.0,0.16666666666666669,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+403,Chai-1,7TE8_P0T,0.0,0.47368421052631565,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+404,Chai-1,7QF4_RBF,0.0,0.25,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 4, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+405,Chai-1,7UJ4_OQ4,0.5,0.1578947368421052,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+406,Chai-1,8EAB_VN2,0.33333333333333337,0.2727272727272727,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+407,Chai-1,7Q25_8J9,0.20000000000000007,0.06666666666666665,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 3, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 3, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+408,Chai-1,7TH4_FFO,0.39999999999999997,0.21428571428571425,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+409,Chai-1,8D39_QDB,0.0,0.2727272727272728,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+410,Chai-1,7YZU_DO7,0.0,0.08333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+411,Chai-1,8B8H_OJQ,0.0,0.058823529411764705,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+412,Chai-1,7TOM_5AD,0.33333333333333326,0.375,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+413,Chai-1,7VWF_K55,0.5,0.21739130434782622,"{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+414,Chai-1,7XI7_4RI,0.3333333333333333,0.11111111111111116,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+415,Chai-1,7WPW_F15,0.5,0.14285714285714282,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+416,Chai-1,8SLG_G5A,0.42857142857142866,0.45454545454545453,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+417,Chai-1,7SZA_DUI,0.6000000000000001,0.14285714285714282,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+418,Chai-1,7T3E_SLB,0.5,0.20000000000000007,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+419,Chai-1,8CNH_V6U,0.6000000000000001,0.3333333333333333,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+420,Chai-1,7XRL_FWK,0.3333333333333333,0.27272727272727265,"{'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+421,Chai-1,7Z1Q_NIO,0.0,0.0,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+422,Chai-1,7X5N_5M5,0.0,0.06666666666666667,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+423,Chai-1,7VQ9_ISY,0.3333333333333333,0.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+424,Chai-1,8AQL_PLG,0.14285714285714285,0.41666666666666663,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+425,Chai-1,7TYP_KUR,0.0,0.22727272727272713,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+426,Chai-1,8HFN_XGC,0.6,0.11111111111111113,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+427,Chai-1,8AUH_L9I,0.5,0.75,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+428,Chai-1,7W06_ITN,0.6000000000000001,0.1111111111111111,"{'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+429,Chai-1,7UAS_MBU,0.0,0.2857142857142857,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+430,Chai-1,8GFD_ZHR,0.0,0.21428571428571436,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+431,Chai-1,7UQ3_O2U,0.25,0.08333333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+432,Chai-1,7USH_82V,0.0,0.09090909090909091,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+433,Chai-1,7XG5_PLP,0.0,0.10000000000000009,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+434,Chai-1,7WUX_6OI,0.3333333333333334,0.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1}"
+435,Chai-1,7QHL_D5P,0.0,0.125,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+436,Chai-1,7Q5I_I0F,0.14285714285714285,0.0,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+437,Chai-1,8DKO_TFB,0.0,0.0,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+438,Chai-1,8G6P_API,1.1666666666666667,0.9999999999999999,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+439,Chai-1,7ULC_56B,0.0,0.35294117647058826,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+440,Chai-1,7SFO_98L,0.0,0.1875,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+441,Chai-1,8DP2_UMA,0.4444444444444445,0.21428571428571425,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+442,Chai-1,7ZZW_KKW,0.3333333333333333,0.39999999999999997,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 2}"
+443,Chai-1,7XFA_D9J,0.0,0.22222222222222215,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+444,Chai-1,7WDT_NGS,0.25,0.11111111111111105,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+445,Chai-1,7WY1_D0L,0.0,0.10526315789473684,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+446,Chai-1,7ZHP_IQY,0.3333333333333333,0.13636363636363627,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+447,Chai-1,7W05_GMP,0.39999999999999997,0.0,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+448,Chai-1,7UJF_R3V,0.0,0.35000000000000003,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+449,Chai-1,8AIE_M7L,0.2,0.4545454545454546,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:VdWContact': 5, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+450,Chai-1,8EYE_X4I,0.39999999999999997,0.3125,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+451,Chai-1,7UY4_SMI,0.0,0.5555555555555556,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+452,Chai-1,7UMW_NAD,0.33333333333333337,0.05263157894736842,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+453,Chai-1,7U3J_L6U,0.28571428571428575,0.19047619047619035,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+454,Chai-1,7QGP_DJ8,0.5,0.2777777777777777,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+455,Chai-1,7FT9_4MB,0.0,0.1538461538461538,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+456,Chai-1,7TM6_GPJ,0.1428571428571428,0.0,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:HBDonor': 2, 'UNL:LYS:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+457,Chai-1,7WQQ_5Z6,0.6666666666666666,0.23076923076923062,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 4, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+458,Chai-1,7WL4_JFU,0.0,0.19999999999999998,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+459,Chai-1,7Z2O_IAJ,0.0,0.33333333333333337,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+460,Chai-1,8FLV_ZB9,0.0,0.21052631578947367,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+461,Chai-1,7T0D_FPP,0.0,0.16666666666666669,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 4}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 5}"
+462,Chai-1,7Z7F_IF3,0.0,0.4,"{'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+463,Chai-1,7TSF_H4B,0.25,0.07692307692307693,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+464,Chai-1,7TUO_KL9,0.3333333333333333,0.14285714285714285,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+465,Chai-1,7ZL5_IWE,0.5,0.6363636363636362,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+466,Chai-1,8F8E_XJI,0.5,0.09999999999999998,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+467,Chai-1,7Q2B_M6H,0.0,0.1666666666666667,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+468,Chai-1,7ZOC_T8E,0.0,0.09090909090909094,"{'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+469,Chai-1,7WCF_ACP,0.16666666666666666,0.0,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+470,Chai-1,7TS6_KMI,0.0,0.36363636363636365,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+471,Chai-1,8D5D_5DK,0.4000000000000001,0.26666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+472,Chai-1,7TBU_S3P,0.5,0.14285714285714285,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+473,Chai-1,8AP0_PRP,0.25,0.125,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+474,Chai-1,7UXS_OJC,0.14285714285714285,0.2777777777777778,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+475,Chai-1,7X9K_8OG,0.25,0.1538461538461538,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+476,Chai-1,8BOM_QU6,0.0,0.09523809523809534,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+477,Chai-1,5SIS_JSM,0.0,0.1666666666666666,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+478,Chai-1,5SD5_HWI,0.25,0.3333333333333334,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+479,Chai-1,7R3D_APR,0.14285714285714285,0.27272727272727276,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+480,Chai-1,7WJB_BGC,0.4000000000000001,0.16666666666666666,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+481,Chai-1,7UTW_NAI,0.2222222222222222,0.1875,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+482,Chai-1,7QPP_VDX,0.33333333333333337,0.0625,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+483,Chai-1,8FAV_4Y5,0.25,0.16666666666666657,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+484,Chai-1,8CSD_C5P,0.39999999999999997,0.36363636363636365,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+485,Chai-1,7SIU_9ID,0.3333333333333333,0.55,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+486,Chai-1,7VYJ_CA0,0.0,0.16666666666666669,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+487,Chai-1,7QHG_T3B,0.16666666666666666,0.3043478260869564,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+488,Boltz-1-Single-Seq,8AAU_LH0,0.0,0.4285714285714285,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+489,Boltz-1-Single-Seq,7UAW_MF6,0.5,0.29999999999999993,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+490,Boltz-1-Single-Seq,7UJ5_DGL,0.4285714285714286,0.16666666666666663,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+491,Boltz-1-Single-Seq,7UYB_OK0,0.0,0.07692307692307698,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+492,Boltz-1-Single-Seq,7U0U_FK5,0.0,0.2857142857142857,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+493,Boltz-1-Single-Seq,8D19_GSH,0.16666666666666669,0.18181818181818188,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+494,Boltz-1-Single-Seq,8C3N_ADP,0.16666666666666666,0.22222222222222215,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+495,Boltz-1-Single-Seq,7XQZ_FPF,0.75,0.05882352941176472,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+496,Boltz-1-Single-Seq,7TXK_LW8,0.0,0.125,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+497,Boltz-1-Single-Seq,7R59_I5F,0.0,0.1111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+498,Boltz-1-Single-Seq,7QFM_AY3,0.3333333333333333,0.4375,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+499,Boltz-1-Single-Seq,8DSC_NCA,0.0,0.4000000000000001,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+500,Boltz-1-Single-Seq,7XBV_APC,0.0,0.23076923076923078,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+501,Boltz-1-Single-Seq,7ZDY_6MJ,0.5,0.16666666666666663,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+502,Boltz-1-Single-Seq,7V14_ORU,0.0,0.1538461538461539,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+503,Boltz-1-Single-Seq,7Q27_8KC,0.25,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 3, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+504,Boltz-1-Single-Seq,8DHG_T78,0.0,0.3157894736842105,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+505,Boltz-1-Single-Seq,8EXL_799,0.6666666666666666,0.09999999999999998,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+506,Boltz-1-Single-Seq,7THI_PGA,0.16666666666666663,0.14285714285714285,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+507,Boltz-1-Single-Seq,7XPO_UPG,0.3333333333333333,0.33333333333333326,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+508,Boltz-1-Single-Seq,7TE8_P0T,0.0,0.49999999999999994,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+509,Boltz-1-Single-Seq,7QF4_RBF,0.0,0.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+510,Boltz-1-Single-Seq,7UJ4_OQ4,0.5,0.22222222222222215,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+511,Boltz-1-Single-Seq,7TH4_FFO,0.3333333333333333,0.4285714285714286,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+512,Boltz-1-Single-Seq,7YZU_DO7,0.16666666666666666,0.41666666666666674,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+513,Boltz-1-Single-Seq,8B8H_OJQ,0.375,0.05555555555555555,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+514,Boltz-1-Single-Seq,7TOM_5AD,0.5,0.33333333333333337,"{'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+515,Boltz-1-Single-Seq,7VWF_K55,0.5,0.2173913043478261,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+516,Boltz-1-Single-Seq,7XI7_4RI,0.3333333333333333,0.2222222222222222,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+517,Boltz-1-Single-Seq,7WKL_CAQ,0.5,0.0,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+518,Boltz-1-Single-Seq,7WPW_F15,0.5,0.2666666666666668,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+519,Boltz-1-Single-Seq,8SLG_G5A,0.33333333333333326,0.2727272727272728,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+520,Boltz-1-Single-Seq,7SZA_DUI,0.39999999999999997,0.2666666666666667,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+521,Boltz-1-Single-Seq,7T3E_SLB,0.4285714285714285,0.25,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+522,Boltz-1-Single-Seq,7ZF0_DHR,0.5,0.33333333333333326,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3}"
+523,Boltz-1-Single-Seq,7X5N_5M5,0.0,0.2777777777777778,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+524,Boltz-1-Single-Seq,7VQ9_ISY,1.3333333333333335,0.07692307692307687,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+525,Boltz-1-Single-Seq,7TYP_KUR,0.5,0.2727272727272727,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+526,Boltz-1-Single-Seq,7XJN_NSD,0.3333333333333333,0.6666666666666667,"{'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 5, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+527,Boltz-1-Single-Seq,8HFN_XGC,0.16666666666666666,0.17647058823529405,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+528,Boltz-1-Single-Seq,8AUH_L9I,0.5,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+529,Boltz-1-Single-Seq,7W06_ITN,0.5,0.11111111111111105,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+530,Boltz-1-Single-Seq,7UAS_MBU,0.0,0.25,"{'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+531,Boltz-1-Single-Seq,8GFD_ZHR,0.25,0.3333333333333333,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+532,Boltz-1-Single-Seq,7UQ3_O2U,0.0,0.09090909090909091,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+533,Boltz-1-Single-Seq,7USH_82V,0.0,0.18181818181818182,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+534,Boltz-1-Single-Seq,7XG5_PLP,0.0,0.30000000000000004,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+535,Boltz-1-Single-Seq,7QHL_D5P,0.5,0.1666666666666667,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+536,Boltz-1-Single-Seq,7Q5I_I0F,0.14285714285714285,0.3333333333333334,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+537,Boltz-1-Single-Seq,8DKO_TFB,0.0,0.16666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+538,Boltz-1-Single-Seq,8G6P_API,0.1111111111111111,0.09090909090909094,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 2, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+539,Boltz-1-Single-Seq,7ULC_56B,0.3333333333333333,0.19999999999999996,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+540,Boltz-1-Single-Seq,7SFO_98L,0.5,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+541,Boltz-1-Single-Seq,8DP2_UMA,0.0,0.06666666666666665,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+542,Boltz-1-Single-Seq,7XFA_D9J,0.0,0.4000000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+543,Boltz-1-Single-Seq,7WDT_NGS,0.16666666666666669,0.5555555555555556,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+544,Boltz-1-Single-Seq,7ZHP_IQY,0.0,0.21052631578947367,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+545,Boltz-1-Single-Seq,7W05_GMP,0.39999999999999997,0.1111111111111111,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+546,Boltz-1-Single-Seq,7UJF_R3V,0.5,0.2272727272727272,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 9, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+547,Boltz-1-Single-Seq,8AIE_M7L,0.5,0.3,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 5, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+548,Boltz-1-Single-Seq,8EYE_X4I,0.25,0.25,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+549,Boltz-1-Single-Seq,7UY4_SMI,0.3333333333333333,0.25000000000000006,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+550,Boltz-1-Single-Seq,7UMW_NAD,0.2857142857142857,0.05263157894736836,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+551,Boltz-1-Single-Seq,7U3J_L6U,0.1428571428571429,0.15789473684210525,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+552,Boltz-1-Single-Seq,7QGP_DJ8,0.0,0.21052631578947362,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+553,Boltz-1-Single-Seq,7FT9_4MB,0.0,0.16666666666666669,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+554,Boltz-1-Single-Seq,7TM6_GPJ,0.4285714285714286,0.75,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+555,Boltz-1-Single-Seq,7WQQ_5Z6,0.5,0.19999999999999998,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+556,Boltz-1-Single-Seq,7WL4_JFU,0.0,0.11111111111111105,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+557,Boltz-1-Single-Seq,7Z2O_IAJ,0.0,0.23076923076923078,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+558,Boltz-1-Single-Seq,8FLV_ZB9,0.0,0.15,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+559,Boltz-1-Single-Seq,7Z7F_IF3,0.3333333333333333,0.09090909090909094,"{'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+560,Boltz-1-Single-Seq,7TUO_KL9,0.25,0.48000000000000004,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+561,Boltz-1-Single-Seq,7ZL5_IWE,0.0,0.5833333333333333,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+562,Boltz-1-Single-Seq,8F8E_XJI,0.0,0.49999999999999994,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+563,Boltz-1-Single-Seq,7WCF_ACP,0.0,0.11111111111111113,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 4, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+564,Boltz-1-Single-Seq,8D5D_5DK,0.33333333333333337,0.11764705882352944,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+565,Boltz-1-Single-Seq,7TBU_S3P,0.39999999999999997,0.5,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 5, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+566,Boltz-1-Single-Seq,8AP0_PRP,0.11111111111111116,0.25,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+567,Boltz-1-Single-Seq,7UXS_OJC,0.0,0.2857142857142856,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+568,Boltz-1-Single-Seq,7X9K_8OG,0.125,0.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+569,Boltz-1-Single-Seq,8BOM_QU6,0.0,0.09523809523809534,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+570,Boltz-1-Single-Seq,5SIS_JSM,0.0,0.16666666666666669,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+571,Boltz-1-Single-Seq,5SD5_HWI,0.5,0.3076923076923078,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+572,Boltz-1-Single-Seq,7R3D_APR,0.0,0.33333333333333337,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+573,Boltz-1-Single-Seq,7WJB_BGC,0.0,0.16666666666666666,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+574,Boltz-1-Single-Seq,7UTW_NAI,0.0,0.0625,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+575,Boltz-1-Single-Seq,7QPP_VDX,0.25,0.125,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+576,Boltz-1-Single-Seq,7VKZ_NOJ,0.8,0.125,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+577,Boltz-1-Single-Seq,8FAV_4Y5,0.6000000000000001,0.1363636363636363,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 4, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+578,Boltz-1-Single-Seq,8CSD_C5P,0.6,0.2727272727272728,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+579,Boltz-1-Single-Seq,7SIU_9ID,0.0,0.4210526315789473,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+580,Boltz-1-Single-Seq,7QHG_T3B,0.4,0.20833333333333337,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+581,Boltz-1,8AAU_LH0,0.0,0.3571428571428571,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+582,Boltz-1,7UAW_MF6,0.4999999999999999,0.3,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+583,Boltz-1,7UJ5_DGL,0.4285714285714286,0.24999999999999997,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+584,Boltz-1,7UYB_OK0,0.0,0.23076923076923084,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+585,Boltz-1,7U0U_FK5,0.5,0.3214285714285714,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+586,Boltz-1,8D19_GSH,0.39999999999999997,0.5454545454545456,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+587,Boltz-1,8C3N_ADP,0.30000000000000004,0.22222222222222215,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+588,Boltz-1,7XQZ_FPF,0.0,0.15789473684210525,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+589,Boltz-1,7TXK_LW8,0.5,0.23529411764705888,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+590,Boltz-1,7R59_I5F,0.0,0.1111111111111111,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+591,Boltz-1,7QFM_AY3,0.6666666666666667,0.4375,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+592,Boltz-1,8DSC_NCA,0.0,0.5,"{'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+593,Boltz-1,7XBV_APC,0.0,0.16666666666666663,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+594,Boltz-1,7ZDY_6MJ,0.5,0.16666666666666663,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+595,Boltz-1,7V14_ORU,0.0,0.1538461538461539,"{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+596,Boltz-1,7Q27_8KC,0.25,0.3529411764705882,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+597,Boltz-1,8DHG_T78,0.3333333333333333,0.09999999999999987,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+598,Boltz-1,8EXL_799,0.25,0.23809523809523808,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+599,Boltz-1,7THI_PGA,0.6666666666666666,0.33333333333333326,"{'UNL:ARG:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+600,Boltz-1,7XPO_UPG,0.25,0.33333333333333326,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+601,Boltz-1,7TE8_P0T,0.0,0.36363636363636365,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 3, 'UNL:ASN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+602,Boltz-1,7QF4_RBF,0.0,0.0625,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 4, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+603,Boltz-1,7UJ4_OQ4,0.5,0.25,"{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+604,Boltz-1,8EAB_VN2,0.0,0.4166666666666665,"{'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+605,Boltz-1,7TH4_FFO,0.1428571428571429,0.39999999999999997,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+606,Boltz-1,7YZU_DO7,0.16666666666666666,0.5000000000000001,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+607,Boltz-1,8B8H_OJQ,0.29999999999999993,0.05263157894736842,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+608,Boltz-1,7TOM_5AD,0.39999999999999997,0.22222222222222224,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+609,Boltz-1,7VWF_K55,0.33333333333333337,0.13043478260869568,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+610,Boltz-1,7XI7_4RI,0.3333333333333333,0.11111111111111116,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+611,Boltz-1,7WPW_F15,0.0,0.3125,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+612,Boltz-1,8SLG_G5A,0.33333333333333326,0.2727272727272727,"{'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+613,Boltz-1,7SZA_DUI,0.6000000000000001,0.0,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+614,Boltz-1,7T3E_SLB,0.3333333333333333,0.19999999999999998,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+615,Boltz-1,7ZF0_DHR,0.5,0.2,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3}"
+616,Boltz-1,7X5N_5M5,0.25,0.16666666666666669,"{'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+617,Boltz-1,7VQ9_ISY,1.0,0.07692307692307687,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+618,Boltz-1,8HFN_XGC,0.16666666666666666,0.11764705882352942,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+619,Boltz-1,8AUH_L9I,0.5,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+620,Boltz-1,7W06_ITN,0.2857142857142857,0.3,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+621,Boltz-1,7UAS_MBU,0.0,0.19999999999999996,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+622,Boltz-1,8GFD_ZHR,0.25,0.3125,"{'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+623,Boltz-1,7UQ3_O2U,0.0,0.09090909090909091,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+624,Boltz-1,7USH_82V,0.0,0.18181818181818182,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+625,Boltz-1,7XG5_PLP,0.0,0.30000000000000004,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+626,Boltz-1,7QHL_D5P,0.6666666666666666,1.0952380952380953,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+627,Boltz-1,7Q5I_I0F,0.2857142857142857,0.38461538461538464,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+628,Boltz-1,8DKO_TFB,0.0,0.2,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+629,Boltz-1,8G6P_API,0.22222222222222215,0.09090909090909094,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:HBDonor': 2, 'UNL:LYS:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+630,Boltz-1,7ULC_56B,0.0,0.19999999999999996,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+631,Boltz-1,7SFO_98L,0.5,0.1875,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+632,Boltz-1,8DP2_UMA,0.2222222222222222,0.06666666666666665,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+633,Boltz-1,7XFA_D9J,0.0,0.4000000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+634,Boltz-1,7WDT_NGS,0.8,0.7777777777777778,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+635,Boltz-1,7ZHP_IQY,0.0,0.21052631578947367,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+636,Boltz-1,7W05_GMP,0.2,0.25,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+637,Boltz-1,7UJF_R3V,0.0,0.2727272727272727,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+638,Boltz-1,8AIE_M7L,1.0,0.25000000000000006,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:VdWContact': 5, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+639,Boltz-1,8EYE_X4I,0.1428571428571429,0.125,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+640,Boltz-1,7UY4_SMI,0.3333333333333333,0.36363636363636365,"{'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+641,Boltz-1,7UMW_NAD,0.2857142857142857,0.05555555555555555,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+642,Boltz-1,7U3J_L6U,0.14285714285714285,0.04999999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+643,Boltz-1,7QGP_DJ8,0.0,0.2631578947368421,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+644,Boltz-1,7FT9_4MB,0.3333333333333333,0.21428571428571427,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+645,Boltz-1,7TM6_GPJ,0.8333333333333333,0.375,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 3, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+646,Boltz-1,7WQQ_5Z6,0.5,0.23076923076923078,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+647,Boltz-1,7WL4_JFU,0.0,0.17647058823529416,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+648,Boltz-1,7Z2O_IAJ,0.0,0.15384615384615385,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+649,Boltz-1,8FLV_ZB9,0.0,0.19999999999999993,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+650,Boltz-1,7Z7F_IF3,0.6666666666666667,0.29999999999999993,"{'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+651,Boltz-1,7TUO_KL9,0.3333333333333333,0.5416666666666666,"{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+652,Boltz-1,7ZL5_IWE,0.0,0.7272727272727273,"{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 6, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+653,Boltz-1,8F8E_XJI,0.3333333333333333,0.6499999999999999,"{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+654,Boltz-1,7ZOC_T8E,0.0,0.2500000000000001,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+655,Boltz-1,7WCF_ACP,0.0,0.10526315789473689,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 4, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+656,Boltz-1,8D5D_5DK,0.6000000000000001,0.1875,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+657,Boltz-1,7TBU_S3P,0.2857142857142857,0.909090909090909,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 2, 'UNL:LYS:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+658,Boltz-1,8AP0_PRP,0.16666666666666669,0.2222222222222222,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+659,Boltz-1,7UXS_OJC,0.0,0.38461538461538447,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 4, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+660,Boltz-1,7X9K_8OG,0.125,0.07692307692307693,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+661,Boltz-1,8BOM_QU6,0.0,0.09523809523809534,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+662,Boltz-1,5SIS_JSM,0.5,0.11764705882352941,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+663,Boltz-1,5SD5_HWI,0.25,0.3571428571428572,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+664,Boltz-1,7R3D_APR,0.2,0.5454545454545455,"{'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 5}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+665,Boltz-1,7WJB_BGC,0.3333333333333334,0.2857142857142857,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+666,Boltz-1,7UTW_NAI,0.0,0.1875,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 3}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+667,Boltz-1,7QPP_VDX,0.5,0.1875,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+668,Boltz-1,7VKZ_NOJ,0.5,0.25,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+669,Boltz-1,8CSD_C5P,0.5,0.16666666666666669,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+670,Boltz-1,7SIU_9ID,0.3333333333333333,0.6,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+671,Boltz-1,7QHG_T3B,0.4,0.19999999999999993,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+672,AF3-Single-Seq,7UAW_MF6,1.2857142857142856,1.1666666666666667,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+673,AF3-Single-Seq,7UJ5_DGL,0.5555555555555556,0.39999999999999997,"{'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+674,AF3-Single-Seq,7UYB_OK0,0.3333333333333333,0.17647058823529416,"{'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+675,AF3-Single-Seq,7U0U_FK5,0.3333333333333333,0.4137931034482759,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 5, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+676,AF3-Single-Seq,8D19_GSH,0.3333333333333333,0.2857142857142858,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+677,AF3-Single-Seq,8C3N_ADP,0.14285714285714285,0.44444444444444436,"{'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+678,AF3-Single-Seq,8A1H_DLZ,0.5,1.125,"{'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+679,AF3-Single-Seq,7XQZ_FPF,0.8,0.4500000000000001,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+680,AF3-Single-Seq,7TXK_LW8,0.3333333333333333,0.5714285714285714,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 4, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+681,AF3-Single-Seq,7QFM_AY3,0.3333333333333333,0.14285714285714282,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+682,AF3-Single-Seq,8DSC_NCA,0.0,0.6666666666666665,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+683,AF3-Single-Seq,7XBV_APC,0.1111111111111111,0.5,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+684,AF3-Single-Seq,7ZDY_6MJ,0.0,0.4444444444444445,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+685,AF3-Single-Seq,7V14_ORU,0.0,0.5,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+686,AF3-Single-Seq,7Q27_8KC,0.8,0.40000000000000013,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+687,AF3-Single-Seq,7THI_PGA,0.2222222222222222,0.6666666666666666,"{'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 5}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+688,AF3-Single-Seq,7XPO_UPG,0.9999999999999999,0.4285714285714285,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+689,AF3-Single-Seq,7TE8_P0T,0.3333333333333333,0.5238095238095237,"{'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 2, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 3, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+690,AF3-Single-Seq,7UJ4_OQ4,0.0,0.6500000000000001,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+691,AF3-Single-Seq,8EAB_VN2,0.25,0.4782608695652173,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 6}","{'UNL:ILE:Hydrophobic': 4, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 2, 'UNL:LYS:Hydrophobic': 2, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}"
+692,AF3-Single-Seq,7TH4_FFO,0.16666666666666663,0.5555555555555556,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+693,AF3-Single-Seq,8D39_QDB,0.3333333333333333,0.14285714285714282,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+694,AF3-Single-Seq,7YZU_DO7,0.8333333333333334,0.2666666666666666,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+695,AF3-Single-Seq,8B8H_OJQ,0.49999999999999994,0.5,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+696,AF3-Single-Seq,7TOM_5AD,0.5999999999999999,0.5882352941176471,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+697,AF3-Single-Seq,7XI7_4RI,0.0,0.4285714285714286,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+698,AF3-Single-Seq,7WPW_F15,0.5,0.3125,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+699,AF3-Single-Seq,8SLG_G5A,1.0,0.375,"{'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+700,AF3-Single-Seq,7SZA_DUI,0.6000000000000001,0.3125,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+701,AF3-Single-Seq,7T3E_SLB,0.6666666666666666,0.4000000000000001,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+702,AF3-Single-Seq,8G0V_YHT,0.5714285714285715,0.3333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+703,AF3-Single-Seq,7XRL_FWK,0.5,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+704,AF3-Single-Seq,7VQ9_ISY,0.19999999999999996,0.6000000000000001,"{'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+705,AF3-Single-Seq,8AQL_PLG,1.0,0.5384615384615383,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+706,AF3-Single-Seq,8HFN_XGC,0.6666666666666667,0.5454545454545454,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 6, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+707,AF3-Single-Seq,7W06_ITN,1.2000000000000002,1.1428571428571428,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+708,AF3-Single-Seq,7UAS_MBU,0.0,0.29411764705882354,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+709,AF3-Single-Seq,8GFD_ZHR,0.3333333333333333,0.21428571428571425,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+710,AF3-Single-Seq,7UQ3_O2U,0.5,0.125,"{'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+711,AF3-Single-Seq,7XG5_PLP,0.49999999999999994,0.2142857142857142,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+712,AF3-Single-Seq,8G6P_API,0.9999999999999999,0.625,"{'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+713,AF3-Single-Seq,8DP2_UMA,0.5,0.23529411764705876,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+714,AF3-Single-Seq,7XFA_D9J,0.3333333333333333,0.5714285714285714,"{'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+715,AF3-Single-Seq,7WDT_NGS,0.6000000000000001,0.4285714285714286,"{'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+716,AF3-Single-Seq,8AEM_LVF,0.0,0.2857142857142857,"{'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+717,AF3-Single-Seq,7W05_GMP,0.5714285714285715,0.4,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+718,AF3-Single-Seq,8AIE_M7L,1.2,0.3076923076923076,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+719,AF3-Single-Seq,8EYE_X4I,0.5714285714285715,0.4000000000000002,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+720,AF3-Single-Seq,7UMW_NAD,0.25,0.4761904761904762,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+721,AF3-Single-Seq,7U3J_L6U,0.8333333333333334,0.2857142857142858,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+722,AF3-Single-Seq,7QGP_DJ8,0.3333333333333333,0.11538461538461547,"{'UNL:ALA:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+723,AF3-Single-Seq,7WQQ_5Z6,0.3333333333333333,0.4705882352941177,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+724,AF3-Single-Seq,7TSF_H4B,0.3333333333333333,0.22222222222222227,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+725,AF3-Single-Seq,7TUO_KL9,0.5,0.45000000000000007,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+726,AF3-Single-Seq,7ZL5_IWE,0.3333333333333333,0.6875,"{'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 2, 'UNL:HIS:VdWContact': 6, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+727,AF3-Single-Seq,8F8E_XJI,0.0,0.44444444444444436,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+728,AF3-Single-Seq,7ZOC_T8E,0.0,0.1875,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+729,AF3-Single-Seq,7WCF_ACP,0.4285714285714286,0.18181818181818182,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+730,AF3-Single-Seq,8D5D_5DK,0.8333333333333334,0.23809523809523808,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+731,AF3-Single-Seq,7TBU_S3P,0.6000000000000001,0.4,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 3, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+732,AF3-Single-Seq,7TB0_UD1,0.375,0.5263157894736843,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+733,AF3-Single-Seq,8AP0_PRP,0.22222222222222215,0.22222222222222232,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+734,AF3-Single-Seq,7UXS_OJC,0.5714285714285715,0.2941176470588236,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+735,AF3-Single-Seq,7X9K_8OG,0.875,0.20000000000000007,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+736,AF3-Single-Seq,5SD5_HWI,0.5,0.17647058823529416,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+737,AF3-Single-Seq,7WJB_BGC,0.75,0.5714285714285714,"{'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+738,AF3-Single-Seq,7UTW_NAI,0.375,0.2631578947368421,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+739,AF3-Single-Seq,8A2D_KXY,0.5,0.4074074074074075,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 3, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+740,AF3-Single-Seq,7VKZ_NOJ,0.5,0.22222222222222227,"{'UNL:ALA:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+741,AF3-Single-Seq,8CSD_C5P,0.5,0.1875,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+742,AF3-Single-Seq,7SIU_9ID,0.5,0.3684210526315788,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 4, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+743,AF3-Single-Seq,8HO0_3ZI,0.0,0.17647058823529405,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+744,AF3,8AAU_LH0,0.0,0.4666666666666666,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+745,AF3,7UAW_MF6,0.42857142857142855,0.49999999999999994,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 4, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 4, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+746,AF3,7UJ5_DGL,0.29999999999999993,0.09090909090909083,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+747,AF3,7UYB_OK0,0.0,0.1538461538461539,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}"
+748,AF3,7U0U_FK5,0.0,0.4166666666666668,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 5, 'UNL:PHE:VdWContact': 5, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU-:Hydrophobic': 1, 'UNL:GLU-:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE-:Hydrophobic': 1, 'UNL:PHE-:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO-:Hydrophobic': 1, 'UNL:TRP-:HBAcceptor': 1, 'UNL:TRP-:Hydrophobic': 1, 'UNL:TRP-:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+749,AF3,8D19_GSH,0.75,0.125,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PRO:VdWContact': 1}"
+750,AF3,8C3N_ADP,0.14285714285714285,0.44444444444444436,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1}"
+751,AF3,8A1H_DLZ,0.0,0.39999999999999997,"{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:VdWContact': 3, 'UNL:LIG:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 3, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+752,AF3,7XQZ_FPF,0.25,0.16666666666666674,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+753,AF3,7TXK_LW8,0.0,0.15384615384615385,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+754,AF3,7R59_I5F,0.5,0.125,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+755,AF3,7QFM_AY3,0.5,0.07692307692307693,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+756,AF3,7QTA_URI,0.0,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1}"
+757,AF3,8DSC_NCA,0.0,0.5,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1}"
+758,AF3,7XBV_APC,0.0,0.08333333333333337,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+759,AF3,7ZDY_6MJ,0.75,0.33333333333333337,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 3}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:VdWContact': 2}"
+760,AF3,7V14_ORU,0.0,0.21428571428571425,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+761,AF3,7Q27_8KC,0.75,0.28571428571428564,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 3, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+762,AF3,8DHG_T78,0.3333333333333333,0.22222222222222227,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 5, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2}"
+763,AF3,8EXL_799,0.0,0.23809523809523814,"{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+764,AF3,7THI_PGA,0.16666666666666663,0.28571428571428575,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+765,AF3,7XPO_UPG,0.0,0.24999999999999992,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+766,AF3,7QF4_RBF,0.25,0.25,"{'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 4, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 3, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 4, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 2}"
+767,AF3,7UJ4_OQ4,0.0,0.16666666666666669,"{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}"
+768,AF3,7TH4_FFO,0.25,0.16666666666666669,"{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+769,AF3,8D39_QDB,0.0,0.09090909090909094,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+770,AF3,7YZU_DO7,0.33333333333333326,0.08333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2}"
+771,AF3,8B8H_OJQ,0.29999999999999993,0.11764705882352942,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+772,AF3,7TOM_5AD,0.19999999999999996,0.11764705882352941,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+773,AF3,7VWF_K55,0.33333333333333337,0.23809523809523808,"{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 4, 'UNL:VAL:VdWContact': 1}"
+774,AF3,7XI7_4RI,0.3333333333333333,0.2222222222222222,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+775,AF3,7WKL_CAQ,0.0,0.09090909090909091,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+776,AF3,7WPW_F15,0.5,0.14285714285714285,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+777,AF3,8SLG_G5A,0.28571428571428575,0.6363636363636364,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 3, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 3, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:VdWContact': 1}"
+778,AF3,7T3E_SLB,0.5,0.4444444444444444,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 2, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2}"
+779,AF3,8CNH_V6U,0.5,0.27272727272727276,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:HBDonor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+780,AF3,7ZF0_DHR,0.0,0.3333333333333333,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:VAL:Hydrophobic': 3}"
+781,AF3,8G0V_YHT,0.0,0.30769230769230765,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+782,AF3,7XRL_FWK,0.25,0.19999999999999996,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:CYS:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+783,AF3,7X5N_5M5,0.0,0.13333333333333333,"{'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+784,AF3,7VQ9_ISY,0.3333333333333333,0.07692307692307693,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1}"
+785,AF3,8AQL_PLG,0.14285714285714285,0.33333333333333326,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 3, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+786,AF3,7TYP_KUR,0.0,0.3636363636363636,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 6, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 2, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+787,AF3,7XJN_NSD,0.0,0.25,"{'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+788,AF3,8HFN_XGC,0.33333333333333337,0.17647058823529416,"{'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+789,AF3,8AUH_L9I,0.3333333333333333,0.5,"{'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:CYS:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:VdWContact': 1}"
+790,AF3,7W06_ITN,0.5,0.125,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 2}"
+791,AF3,7UAS_MBU,0.0,0.35294117647058826,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 3, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASP:Hydrophobic': 2, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+792,AF3,8GFD_ZHR,0.3333333333333333,0.16666666666666657,"{'UNL:ALA:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+793,AF3,7UQ3_O2U,0.25,0.08333333333333333,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+794,AF3,7USH_82V,0.0,0.09090909090909091,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2}"
+795,AF3,7XG5_PLP,0.0,0.1,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:THR:HBAcceptor': 2, 'UNL:THR:VdWContact': 3, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+796,AF3,7QHL_D5P,0.6666666666666666,0.125,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+797,AF3,7Q5I_I0F,0.14285714285714285,0.09090909090909091,"{'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1}"
+798,AF3,8DKO_TFB,0.5,0.33333333333333326,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1}"
+799,AF3,8G6P_API,0.16666666666666666,0.0,"{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1}"
+800,AF3,7ULC_56B,0.3333333333333333,0.2142857142857143,"{'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1}"
+801,AF3,7SFO_98L,0.5,0.19999999999999996,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:MET:Hydrophobic': 4, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1}"
+802,AF3,8DP2_UMA,0.1,0.1333333333333333,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1}"
+803,AF3,7XFA_D9J,0.0,0.3,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1}"
+804,AF3,7WDT_NGS,0.0,0.30000000000000004,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 4, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:HBAcceptor': 1, 'UNL:TRP:Hydrophobic': 3, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+805,AF3,7WY1_D0L,0.0,0.11111111111111113,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 5, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 2, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 4, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+806,AF3,7ZHP_IQY,0.0,0.20000000000000004,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+807,AF3,7W05_GMP,0.0,0.125,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2}"
+808,AF3,7UJF_R3V,0.0,0.25,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 3, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+809,AF3,8AIE_M7L,0.6000000000000001,0.18181818181818174,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 2, 'UNL:SER:VdWContact': 2, 'UNL:THR:HBAcceptor': 3, 'UNL:THR:HBDonor': 2, 'UNL:THR:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+810,AF3,8EYE_X4I,0.33333333333333326,0.06666666666666665,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:HBAcceptor': 2, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 5, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+811,AF3,7UMW_NAD,0.16666666666666666,0.05555555555555558,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:HBAcceptor': 2, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 3, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+812,AF3,7U3J_L6U,0.4285714285714286,0.22222222222222207,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 2, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 3}"
+813,AF3,7QGP_DJ8,0.25,0.05000000000000002,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+814,AF3,7FT9_4MB,0.0,0.3333333333333334,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:SER:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1}"
+815,AF3,7TM6_GPJ,0.125,0.14285714285714285,"{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 3, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2}"
+816,AF3,7WQQ_5Z6,0.6666666666666666,0.35714285714285704,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 3, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:Hydrophobic': 2, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 4, 'UNL:PHE:VdWContact': 4, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+817,AF3,7WL4_JFU,0.0,0.05263157894736842,"{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 2, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+818,AF3,7Z2O_IAJ,0.0,0.30000000000000004,"{'UNL:ALA:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 3, 'UNL:VAL:Hydrophobic': 1}"
+819,AF3,8FLV_ZB9,0.0,0.05555555555555558,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+820,AF3,7Z7F_IF3,0.25,0.18181818181818182,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 3, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 2, 'UNL:CYS:HBDonor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:VdWContact': 2, 'UNL:TRP:Hydrophobic': 2, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:VdWContact': 1}"
+821,AF3,7TSF_H4B,0.25,0.16666666666666666,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:VdWContact': 1}"
+822,AF3,7ZL5_IWE,0.3333333333333333,0.36363636363636354,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 4, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:VdWContact': 1}"
+823,AF3,8F8E_XJI,0.0,0.0,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 2, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 2, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+824,AF3,7Q2B_M6H,0.0,0.2142857142857143,"{'UNL:CYS:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+825,AF3,7ZOC_T8E,0.5,0.23076923076923073,"{'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 2, 'UNL:GLU:VdWContact': 4, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ASN:Hydrophobic': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 4, 'UNL:HIS:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 2}"
+826,AF3,7WCF_ACP,0.0,0.19999999999999993,"{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 2, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 3, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 1}"
+827,AF3,7TS6_KMI,0.0,0.19999999999999998,"{'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TRP:HBDonor': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+828,AF3,8D5D_5DK,0.28571428571428564,0.19999999999999998,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBAcceptor': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:Hydrophobic': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:Hydrophobic': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 3, 'UNL:GLY:VdWContact': 3, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}"
+829,AF3,7TBU_S3P,0.2,0.5,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 4, 'UNL:THR:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 4, 'UNL:TYR:Hydrophobic': 1}"
+830,AF3,7TB0_UD1,0.5,0.11764705882352944,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:VAL:HBAcceptor': 1, 'UNL:VAL:VdWContact': 2}"
+831,AF3,8AP0_PRP,0.125,0.125,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:HBDonor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LYS:HBAcceptor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:SER:HBAcceptor': 2, 'UNL:SER:VdWContact': 3, 'UNL:THR:VdWContact': 1, 'UNL:VAL:VdWContact': 1}"
+832,AF3,7UXS_OJC,0.6,0.19999999999999998,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 1, 'UNL:LYS:VdWContact': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:HBAcceptor': 2, 'UNL:GLY:VdWContact': 2, 'UNL:LEU:HBAcceptor': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:SER:VdWContact': 1, 'UNL:TRP:VdWContact': 1}"
+833,AF3,7X9K_8OG,0.125,0.07692307692307687,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:HBDonor': 1, 'UNL:PHE:VdWContact': 2, 'UNL:PRO:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}"
+834,AF3,8BOM_QU6,0.0,0.09523809523809534,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 4, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 2, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:HBAcceptor': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 2, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+835,AF3,5SIS_JSM,0.0,0.11764705882352941,"{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:GLU:Hydrophobic': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 1, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
+836,AF3,5SD5_HWI,0.25,0.2857142857142858,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 3, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLN:Hydrophobic': 1, 'UNL:ILE:HBDonor': 2, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1}"
+837,AF3,7R3D_APR,0.0,0.41666666666666674,"{'UNL:ASN:HBDonor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:ASP:VdWContact': 2, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LEU:VdWContact': 1, 'UNL:LYS:HBDonor': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PRO:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 3}","{'UNL:ASP:VdWContact': 1, 'UNL:GLY:HBAcceptor': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:Hydrophobic': 2, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:HBAcceptor': 1, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 4}"
+838,AF3,7WJB_BGC,0.6666666666666666,0.0,"{'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TRP:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 2, 'UNL:ASP:VdWContact': 3, 'UNL:GLN:HBDonor': 1, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:VdWContact': 3, 'UNL:TYR:VdWContact': 1}"
+839,AF3,7UTW_NAI,0.14285714285714285,0.125,"{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 4}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 2, 'UNL:ARG:VdWContact': 2, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 2, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:SER:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:HBAcceptor': 2, 'UNL:VAL:HBDonor': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 3}"
+840,AF3,8A2D_KXY,0.5,0.30434782608695654,"{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:LEU:Hydrophobic': 4, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}","{'UNL:ALA:Hydrophobic': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBDonor': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:Hydrophobic': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 2, 'UNL:THR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 3}"
+841,AF3,7QPP_VDX,0.0,0.19999999999999996,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 5, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:CYS:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:HBDonor': 1, 'UNL:HIS:VdWContact': 2, 'UNL:ILE:Hydrophobic': 2, 'UNL:LEU:Hydrophobic': 6, 'UNL:LEU:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:SER:VdWContact': 3, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 3, 'UNL:TYR:VdWContact': 2, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 1}"
+842,AF3,7VKZ_NOJ,0.14285714285714285,0.1428571428571429,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:HBDonor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:VdWContact': 2}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:VdWContact': 1, 'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASN:HBAcceptor': 1, 'UNL:ASN:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:VdWContact': 1, 'UNL:TYR:HBDonor': 1, 'UNL:TYR:VdWContact': 2}"
+843,AF3,8FAV_4Y5,0.25,0.15789473684210542,"{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 2, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TRP:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:ALA:HBAcceptor': 1, 'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:GLN:HBAcceptor': 1, 'UNL:GLN:Hydrophobic': 2, 'UNL:GLN:VdWContact': 3, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:HBAcceptor': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TRP:Hydrophobic': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 1}"
+844,AF3,8CSD_C5P,0.39999999999999997,0.5,"{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:VAL:Hydrophobic': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 2, 'UNL:GLN:VdWContact': 1, 'UNL:HIS:HBAcceptor': 1, 'UNL:HIS:Hydrophobic': 1, 'UNL:HIS:VdWContact': 1, 'UNL:LEU:HBDonor': 1, 'UNL:LEU:VdWContact': 1, 'UNL:PRO:Hydrophobic': 1, 'UNL:SER:HBAcceptor': 1, 'UNL:SER:HBDonor': 2, 'UNL:SER:VdWContact': 3, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+845,AF3,7SIU_9ID,0.0,0.6315789473684209,"{'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:ILE:Hydrophobic': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 3, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ALA:HBDonor': 1, 'UNL:ALA:Hydrophobic': 2, 'UNL:ALA:VdWContact': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:CYS:HBAcceptor': 1, 'UNL:CYS:VdWContact': 1, 'UNL:GLU:HBDonor': 1, 'UNL:GLU:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:PHE:Hydrophobic': 1, 'UNL:PHE:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 1}"
+846,AF3,7QHG_T3B,0.4,0.29166666666666663,"{'UNL:ALA:VdWContact': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 1, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 2, 'UNL:ILE:VdWContact': 1, 'UNL:LEU:Hydrophobic': 8, 'UNL:LEU:VdWContact': 5, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 2, 'UNL:PHE:Hydrophobic': 2, 'UNL:PHE:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:TYR:VdWContact': 1, 'UNL:VAL:Hydrophobic': 2, 'UNL:VAL:VdWContact': 2}","{'UNL:ARG:HBAcceptor': 1, 'UNL:ARG:Hydrophobic': 1, 'UNL:ARG:VdWContact': 1, 'UNL:ASP:HBAcceptor': 1, 'UNL:ASP:Hydrophobic': 1, 'UNL:ASP:VdWContact': 1, 'UNL:GLU:VdWContact': 1, 'UNL:GLY:VdWContact': 2, 'UNL:HIS:VdWContact': 1, 'UNL:ILE:HBAcceptor': 1, 'UNL:ILE:HBDonor': 1, 'UNL:ILE:Hydrophobic': 3, 'UNL:ILE:VdWContact': 2, 'UNL:LEU:Hydrophobic': 7, 'UNL:LEU:VdWContact': 4, 'UNL:LYS:Hydrophobic': 1, 'UNL:LYS:VdWContact': 1, 'UNL:MET:Hydrophobic': 1, 'UNL:MET:VdWContact': 1, 'UNL:PHE:Hydrophobic': 2, 'UNL:THR:HBDonor': 1, 'UNL:THR:Hydrophobic': 1, 'UNL:THR:VdWContact': 1, 'UNL:TYR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 3, 'UNL:VAL:VdWContact': 2}"
+847,AF3,8HO0_3ZI,0.0,0.18181818181818185,"{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 1, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1}","{'UNL:GLN:Hydrophobic': 1, 'UNL:GLN:VdWContact': 1, 'UNL:LEU:Hydrophobic': 3, 'UNL:LEU:VdWContact': 2, 'UNL:LYS:VdWContact': 1, 'UNL:PHE:Hydrophobic': 3, 'UNL:PHE:VdWContact': 2, 'UNL:SER:HBDonor': 1, 'UNL:SER:VdWContact': 2, 'UNL:THR:Hydrophobic': 1, 'UNL:VAL:Hydrophobic': 1, 'UNL:VAL:VdWContact': 1}"
diff --git a/notebooks/posebusters_benchmark_structured_vs_unstructured_plif_emd_values.png b/notebooks/posebusters_benchmark_structured_vs_unstructured_plif_emd_values.png
new file mode 100644
index 00000000..b7aa002d
Binary files /dev/null and b/notebooks/posebusters_benchmark_structured_vs_unstructured_plif_emd_values.png differ
diff --git a/notebooks/posebusters_method_interaction_analysis_plotting.ipynb b/notebooks/posebusters_method_interaction_analysis_plotting.ipynb
index 86bde59e..dde7ed9f 100644
--- a/notebooks/posebusters_method_interaction_analysis_plotting.ipynb
+++ b/notebooks/posebusters_method_interaction_analysis_plotting.ipynb
@@ -88,6 +88,8 @@
" \"rfaa\",\n",
" \"chai-lab_ss\",\n",
" \"chai-lab\",\n",
+ " \"boltz_ss\",\n",
+ " \"boltz\",\n",
" \"alphafold3_ss\",\n",
" \"alphafold3\",\n",
"]\n",
@@ -103,7 +105,7 @@
")\n",
"assert os.path.exists(\n",
" pb_set_dir\n",
- "), \"Please download the PoseBusters Benchmark set from `https://zenodo.org/records/14629652` before proceeding.\"\n",
+ "), \"Please download the PoseBusters Benchmark set from `https://zenodo.org/records/16791095` before proceeding.\"\n",
"\n",
"# PoseBusters Benchmark deposition dates\n",
"pb_deposition_dates_filepath = \"posebusters_benchmark_complex_pdb_deposition_dates.csv\"\n",
@@ -134,6 +136,8 @@
" \"rfaa\": \"RFAA\",\n",
" \"chai-lab_ss\": \"Chai-1-Single-Seq\",\n",
" \"chai-lab\": \"Chai-1\",\n",
+ " \"boltz_ss\": \"Boltz-1-Single-Seq\",\n",
+ " \"boltz\": \"Boltz-1\",\n",
" \"alphafold3_ss\": \"AF3-Single-Seq\",\n",
" \"alphafold3\": \"AF3\",\n",
"}\n",
diff --git a/notebooks/posebusters_method_interaction_analysis_plotting.py b/notebooks/posebusters_method_interaction_analysis_plotting.py
index b38e313d..20707235 100644
--- a/notebooks/posebusters_method_interaction_analysis_plotting.py
+++ b/notebooks/posebusters_method_interaction_analysis_plotting.py
@@ -53,6 +53,8 @@
"rfaa",
"chai-lab_ss",
"chai-lab",
+ "boltz_ss",
+ "boltz",
"alphafold3_ss",
"alphafold3",
]
@@ -68,7 +70,7 @@
)
assert os.path.exists(
pb_set_dir
-), "Please download the PoseBusters Benchmark set from `https://zenodo.org/records/14629652` before proceeding."
+), "Please download the PoseBusters Benchmark set from `https://zenodo.org/records/16791095` before proceeding."
# PoseBusters Benchmark deposition dates
pb_deposition_dates_filepath = "posebusters_benchmark_complex_pdb_deposition_dates.csv"
@@ -99,6 +101,8 @@
"rfaa": "RFAA",
"chai-lab_ss": "Chai-1-Single-Seq",
"chai-lab": "Chai-1",
+ "boltz_ss": "Boltz-1-Single-Seq",
+ "boltz": "Boltz-1",
"alphafold3_ss": "AF3-Single-Seq",
"alphafold3": "AF3",
}
diff --git a/posebench/__init__.py b/posebench/__init__.py
index 0c7eeb80..c96c6d76 100644
--- a/posebench/__init__.py
+++ b/posebench/__init__.py
@@ -14,8 +14,9 @@
"dynamicbind": "DynamicBind",
"neuralplexer": "NeuralPLexer",
"flowdock": "FlowDock",
- "rfaa": "RFAA",
+ "rfaa": "RoseTTAFold-All-Atom",
"chai-lab": "chai-lab",
+ "boltz": "boltz",
"alphafold3": "alphafold3",
"vina": "Vina",
"tulip": "TULIP",
@@ -113,7 +114,7 @@ def resolve_method_protein_dir(
"results",
f"{dataset}{pocket_only_suffix}",
)
- elif method in ["neuralplexer", "flowdock", "rfaa", "chai-lab", "alphafold3"]:
+ elif method in ["neuralplexer", "flowdock", "rfaa", "chai-lab", "boltz", "alphafold3"]:
return os.path.join(
"forks",
METHOD_TITLE_MAPPING.get(method, method),
@@ -165,6 +166,7 @@ def resolve_method_ligand_dir(
"flowdock",
"rfaa",
"chai-lab",
+ "boltz",
"alphafold3",
"tulip",
]:
@@ -176,6 +178,7 @@ def resolve_method_ligand_dir(
"flowdock",
"rfaa",
"chai-lab",
+ "boltz",
"alphafold3",
"tulip",
]
@@ -250,6 +253,7 @@ def resolve_method_output_dir(
"flowdock",
"rfaa",
"chai-lab",
+ "boltz",
"alphafold3",
"tulip",
]:
@@ -261,6 +265,7 @@ def resolve_method_output_dir(
"flowdock",
"rfaa",
"chai-lab",
+ "boltz",
"alphafold3",
"tulip",
]
@@ -321,6 +326,7 @@ def resolve_method_input_csv_path(
"flowdock",
"rfaa",
"chai-lab",
+ "boltz",
"alphafold3",
"vina",
"tulip",
diff --git a/posebench/analysis/complex_alignment.py b/posebench/analysis/complex_alignment.py
index 22334ecd..9fe6171d 100644
--- a/posebench/analysis/complex_alignment.py
+++ b/posebench/analysis/complex_alignment.py
@@ -328,6 +328,7 @@ def main(cfg: DictConfig):
"flowdock",
"rfaa",
"chai-lab",
+ "boltz",
"alphafold3",
]:
output_dir = Path(str(output_dir).replace("_relaxed", ""))
@@ -374,6 +375,20 @@ def main(cfg: DictConfig):
and "_LIG_" not in file.stem
]
)
+ elif cfg.method == "boltz":
+ output_ligand_files = list(
+ output_dir.rglob(f"*_model_{cfg.rank_to_align - 1}_ligand*{config}.sdf")
+ )
+ output_ligand_files = sorted(
+ [
+ file
+ for file in output_ligand_files
+ if config == "_relaxed"
+ or (config == "" and "_relaxed" not in file.stem)
+ and "_aligned" not in file.stem
+ and "_LIG" not in file.stem
+ ]
+ )
elif cfg.method == "alphafold3":
output_ligand_files = list(output_dir.rglob(f"*_model_ligand{config}.sdf"))
output_ligand_files = sorted(
@@ -431,6 +446,18 @@ def main(cfg: DictConfig):
and "_aligned" not in file.stem
]
)
+ elif cfg.method == "boltz":
+ output_protein_files = list(
+ output_dir.rglob(f"*_model_{cfg.rank_to_align - 1}_protein*.pdb")
+ )
+ output_protein_files = sorted(
+ [
+ file
+ for file in output_protein_files
+ if (config == "_relaxed" or (config == "" and "_relaxed" not in file.stem))
+ and "_aligned" not in file.stem
+ ]
+ )
elif cfg.method == "alphafold3":
output_protein_files = list(output_dir.rglob("*_model_protein.pdb"))
output_protein_files = sorted(
@@ -469,6 +496,19 @@ def main(cfg: DictConfig):
)
]
)
+ elif cfg.method == "boltz":
+ output_protein_files = sorted(
+ [
+ item
+ for item in output_dir.rglob(
+ f"*_model_{cfg.rank_to_align - 1}_protein*.pdb"
+ )
+ if "_aligned" not in item.stem
+ and any(
+ [item.parent.stem in file.parent.stem for file in output_ligand_files]
+ )
+ ]
+ )
else:
raise ValueError(
f"Number of protein files ({len(output_protein_files)}) is less than the number of ligand files ({len(output_ligand_files)})."
diff --git a/posebench/analysis/inference_analysis.py b/posebench/analysis/inference_analysis.py
index cc242ee6..63777882 100644
--- a/posebench/analysis/inference_analysis.py
+++ b/posebench/analysis/inference_analysis.py
@@ -249,7 +249,7 @@ def create_mol_table(
with open(cfg.dockgen_test_ids_filepath) as f:
pdb_ids = {line.replace(" ", "-") for line in f.read().splitlines()}
- if cfg.method in ["dynamicbind", "rfaa", "chai-lab", "alphafold3"]:
+ if cfg.method in ["dynamicbind", "rfaa", "chai-lab", "boltz", "alphafold3"]:
# NOTE: for methods such as DynamicBind and RoseTTAFold-All-Atom,
# the input CSV file needs to be created manually from the input data directory
input_smiles_and_pdb_ids = parse_inference_inputs_from_dir(input_data_dir, pdb_ids=pdb_ids)
@@ -343,6 +343,24 @@ def create_mol_table(
else None
)
)
+ elif cfg.method == "boltz":
+ mol_table["mol_cond"] = input_table["pdb_id"].apply(
+ lambda x: (
+ list(
+ (Path(str(inference_dir).replace("_relaxed", "")) / x).rglob(
+ f"*_model_0_protein{'_relaxed' if relaxed_protein else ''}_aligned.pdb"
+ )
+ )[0]
+ if len(
+ list(
+ (Path(str(inference_dir).replace("_relaxed", "")) / x).rglob(
+ f"*_model_0_protein{'_relaxed' if relaxed_protein else ''}_aligned.pdb"
+ )
+ )
+ )
+ else None
+ )
+ )
elif cfg.method == "alphafold3":
mol_table["mol_cond"] = input_table["pdb_id"].apply(
lambda x: (
@@ -503,6 +521,24 @@ def create_mol_table(
else None
)
)
+ elif cfg.method == "boltz":
+ mol_table["mol_pred"] = input_table["pdb_id"].apply(
+ lambda x: (
+ list(
+ (Path(str(inference_dir).replace("_relaxed", "")) / x).rglob(
+ f"*_model_0_ligand{'_relaxed' if relaxed else ''}_aligned.sdf"
+ )
+ )[0]
+ if len(
+ list(
+ (Path(str(inference_dir).replace("_relaxed", "")) / x).rglob(
+ f"*_model_0_ligand{'_relaxed' if relaxed else ''}_aligned.sdf"
+ )
+ )
+ )
+ else None
+ )
+ )
elif cfg.method == "alphafold3":
mol_table["mol_pred"] = input_table["pdb_id"].apply(
lambda x: (
@@ -782,6 +818,30 @@ def create_mol_table(
else None
)
)
+ elif cfg.method == "boltz":
+ mol_table.loc[missing_pred_indices, "mol_pred"] = input_table.loc[
+ missing_pred_indices, "pdb_id"
+ ].apply(
+ lambda x: (
+ glob.glob(
+ os.path.join(
+ Path(str(inference_dir).replace("_relaxed", "")),
+ x,
+ "*_model_0_ligand_aligned.sdf",
+ )
+ )[0]
+ if len(
+ glob.glob(
+ os.path.join(
+ Path(str(inference_dir).replace("_relaxed", "")),
+ x,
+ "*_model_0_ligand_aligned.sdf",
+ )
+ )
+ )
+ else None
+ )
+ )
elif cfg.method == "alphafold3":
mol_table.loc[missing_pred_indices, "mol_pred"] = input_table.loc[
missing_pred_indices, "pdb_id"
diff --git a/posebench/analysis/inference_analysis_casp.py b/posebench/analysis/inference_analysis_casp.py
index 6631f20a..c0d4d4c8 100644
--- a/posebench/analysis/inference_analysis_casp.py
+++ b/posebench/analysis/inference_analysis_casp.py
@@ -228,7 +228,7 @@ def main(cfg: DictConfig):
os.makedirs(scoring_results_filepath.parent, exist_ok=True)
# collect analysis results
- if os.path.exists(scoring_results_filepath) and not cfg.force_rescore:
+ if os.path.exists(scoring_results_filepath) and not cfg.force_casp15_rescore:
logger.info(
f"{resolve_method_title(cfg.method)}{config} analysis results for inference directory `{output_dir}` already exist at `{scoring_results_filepath}`. Directly analyzing..."
)
@@ -279,7 +279,7 @@ def main(cfg: DictConfig):
)
# collect bust results
- if os.path.exists(bust_results_filepath) and not cfg.force_rescore:
+ if os.path.exists(bust_results_filepath) and not cfg.force_pb_rescore:
logger.info(
f"{resolve_method_title(cfg.method)}{config} bust results for inference directory `{output_dir}` already exist at `{bust_results_filepath}`. Directly analyzing..."
)
diff --git a/posebench/analysis/similarity_scoring.py b/posebench/analysis/similarity_scoring.py
new file mode 100644
index 00000000..0d60bc8e
--- /dev/null
+++ b/posebench/analysis/similarity_scoring.py
@@ -0,0 +1,450 @@
+# -------------------------------------------------------------------------------------------------------------------------------------
+# Following code adapted from runs-n-poses: (https://github.com/plinder-org/runs-n-poses)
+# -------------------------------------------------------------------------------------------------------------------------------------
+
+import logging
+import os
+from collections import defaultdict
+from pathlib import Path
+from typing import Optional, Tuple
+
+import numpy as np
+import pandas as pd
+import rootutils
+from plinder.core import get_config
+from plinder.core.scores import query_index
+from plinder.data.utils.annotations.aggregate_annotations import Entry
+from plinder.data.utils.annotations.get_similarity_scores import Scorer
+from rdkit import Chem, DataStructs, RDConfig
+from rdkit.Chem import AllChem, rdShapeAlign, rdShapeHelpers
+from rdkit.Chem.FeatMaps import FeatMaps
+from tqdm import tqdm
+
+rootutils.setup_root(__file__, indicator=".project-root", pythonpath=True)
+
+logging.basicConfig(format="[%(asctime)s] {%(filename)s:%(lineno)d} %(levelname)s - %(message)s")
+logger = logging.getLogger(__name__)
+
+
+PLINDER_DIR = Path(get_config().data.plinder_dir)
+MAIN_DIRECTORY = Path("scoring")
+MAIN_DIRECTORY.mkdir(exist_ok=True, parents=True)
+DIRECTORIES = {
+ "db": MAIN_DIRECTORY / "db",
+ "search": MAIN_DIRECTORY / "search",
+ "scores": MAIN_DIRECTORY / "scores",
+}
+
+
+def align_molecules_crippen(mol_ref, mol_probe, iterations=100):
+ """Align two molecules using the Crippen O3A method.
+
+ :param mol_ref: The reference molecule.
+ :param mol_probe: The probe molecule.
+ :param iterations: The number of iterations for the alignment.
+ """
+ crippenO3A = Chem.rdMolAlign.GetCrippenO3A(mol_probe, mol_ref, maxIters=iterations)
+ crippenO3A.Align()
+
+
+def align_molecules(
+ reference: Chem.Mol,
+ mobile: Chem.Mol,
+ max_preiters: int = 100,
+ max_postiters: int = 100,
+) -> Tuple[float, float, np.ndarray]:
+ """Align two molecules and return the RMSD, Tanimoto, and aligned
+ coordinates.
+
+ :param reference: The reference molecule.
+ :param mobile: The mobile molecule.
+ :param max_preiters: The maximum number of pre-alignment iterations.
+ :param max_postiters: The maximum number of post-alignment
+ iterations.
+ :return: A tuple containing the RMSD, Tanimoto, and aligned
+ coordinates.
+ """
+ align_molecules_crippen(reference, mobile, iterations=max_preiters)
+ return rdShapeAlign.AlignMol(
+ reference,
+ mobile,
+ max_preiters=max_preiters,
+ max_postiters=max_postiters,
+ )
+
+
+# Adapted from https://github.com/susanhleung/SuCOS
+# Initialize feature factory for pharmacophore scoring
+FDEF = AllChem.BuildFeatureFactory(os.path.join(RDConfig.RDDataDir, "BaseFeatures.fdef"))
+
+# Feature map parameters
+FEAT_MAP_PARAMS = {k: FeatMaps.FeatMapParams() for k in FDEF.GetFeatureFamilies()}
+
+# Feature types to keep for pharmacophore scoring
+PHARMACOPHORE_FEATURES = (
+ "Donor",
+ "Acceptor",
+ "NegIonizable",
+ "PosIonizable",
+ "ZnBinder",
+ "Aromatic",
+ "Hydrophobe",
+ "LumpedHydrophobe",
+)
+
+
+def get_feature_map_score(
+ mol_1: Chem.Mol,
+ mol_2: Chem.Mol,
+ score_mode: FeatMaps.FeatMapScoreMode = FeatMaps.FeatMapScoreMode.All,
+) -> float:
+ """Calculate the feature map score between two molecules.
+
+ :param mol_1: The first molecule.
+ :param mol_2: The second molecule.
+ :param score_mode: The scoring mode to use.
+ :return: The feature map score.
+ """
+ feat_lists = []
+ for molecule in [mol_1, mol_2]:
+ raw_feats = FDEF.GetFeaturesForMol(molecule)
+ feat_lists.append([f for f in raw_feats if f.GetFamily() in PHARMACOPHORE_FEATURES])
+
+ feat_maps = [
+ FeatMaps.FeatMap(feats=x, weights=[1] * len(x), params=FEAT_MAP_PARAMS) for x in feat_lists
+ ]
+ feat_maps[0].scoreMode = score_mode
+
+ score = feat_maps[0].ScoreFeats(feat_lists[1])
+ return score / min(feat_maps[0].GetNumFeatures(), len(feat_lists[1]))
+
+
+def get_sucos_score(
+ mol_1: Chem.Mol,
+ mol_2: Chem.Mol,
+ score_mode: FeatMaps.FeatMapScoreMode = FeatMaps.FeatMapScoreMode.All,
+) -> float:
+ """Calculate the SuCOS similarity score of two molecules.
+
+ :param mol_1: The first molecule.
+ :param mol_2: The second molecule.
+ :param score_mode: The scoring mode to use.
+ :return: The SuCOS similarity score.
+ """
+ fm_score = get_feature_map_score(mol_1, mol_2, score_mode)
+ fm_score = np.clip(fm_score, 0, 1)
+
+ protrude_dist = rdShapeHelpers.ShapeProtrudeDist(mol_1, mol_2, allowReordering=False)
+ protrude_dist = np.clip(protrude_dist, 0, 1)
+
+ return 0.5 * fm_score + 0.5 * (1 - protrude_dist)
+
+
+def get_random_conformer(
+ molecule: Chem.Mol,
+ random_seed: int = 42,
+ max_iterations: Optional[int] = None,
+) -> Optional[Chem.Conformer]:
+ """Generate a random conformer using ETKDGv3.
+
+ :param mol: Input molecule
+ :param random_seed: Random seed for reproducibility
+ :param max_iterations: Maximum number of iterations for conformer
+ generation
+ :return: Generated conformer or None if generation fails
+ """
+ params = AllChem.ETKDGv3()
+ params.randomSeed = random_seed
+ if max_iterations is not None:
+ params.maxIterations = max_iterations
+
+ mol_copy = Chem.Mol(molecule)
+ try:
+ conformer_id = AllChem.EmbedMolecule(mol_copy, params)
+ if conformer_id >= 0:
+ return mol_copy
+ return None
+ except ValueError:
+ return None
+
+
+class SimilarityScorer:
+ """Class for calculating similarity scores between systems."""
+
+ def __init__(self):
+ self.db_dir = DIRECTORIES["scores"]
+ self.training_cutoff = pd.to_datetime("2021-09-30")
+ self.output_dir = self.db_dir / "all_scores"
+ self.output_dir.mkdir(parents=True, exist_ok=True)
+ with open("new_pdb_ids.txt") as f:
+ self.new_pdb_ids = set(f.read().split(","))
+ self.fpgen = AllChem.GetRDKitFPGenerator()
+
+ def score_system_plinder(self, pdb_id: str) -> None:
+ """Score a system using PLINDER.
+
+ :param pdb_id: The PDB ID of the system to score.
+ """
+ filename = self.db_dir / f"holo_foldseek/aln/{pdb_id}.parquet"
+ if not filename.exists():
+ logger.info(f"No Foldseek file for {pdb_id}")
+ return None
+ df = pd.read_parquet(filename)
+ target_ids = set(df["target_pdb_id"])
+ entries = {}
+ for p in target_ids.intersection(self.new_pdb_ids):
+ try:
+ entries[p] = Entry.from_json(
+ PLINDER_DIR / "systems" / p[-3:-1] / f"{p}.json"
+ ).prune(
+ clear_non_pocket_residues=True,
+ load_for_scoring=True,
+ max_protein_chains=20,
+ max_ligand_chains=20,
+ )
+ except Exception as e:
+ logger.error(f"Failed to load entry for {p} due to: {e}")
+ continue
+ scorer = Scorer(
+ entries=entries,
+ source_to_full_db_file={},
+ db_dir=self.db_dir,
+ scores_dir=Path("scores"),
+ minimum_threshold=0.0,
+ )
+ scorer.get_score_df(PLINDER_DIR, pdb_id=pdb_id, search_db="holo", overwrite=False)
+
+ def score_system_ligand(self, pdb_id: str):
+ """Score a system using ligand-based methods.
+
+ :param pdb_id: The PDB ID of the system to score.
+ """
+ plinder_score_file = self.db_dir / f"search_db=holo/{pdb_id}.parquet"
+ scores_df = pd.read_parquet(plinder_score_file)
+ system_id_pairs = set(zip(scores_df["query_system"], scores_df["target_system"]))
+ all_systems_to_load = set(scores_df["query_system"]).union(set(scores_df["target_system"]))
+ plindex = query_index(
+ columns=[
+ "system_id",
+ "system_biounit_id",
+ "ligand_instance_chain",
+ "ligand_ccd_code",
+ "ligand_rdkit_canonical_smiles",
+ "system_protein_chains_auth_id",
+ ],
+ filters=[
+ ("system_id", "in", all_systems_to_load),
+ ("ligand_is_proper", "==", True),
+ ],
+ splits=["*"],
+ ).drop(columns=["split"])
+ fps = defaultdict(dict)
+ mols = defaultdict(dict)
+ for system_id, ligand_instance_chain, smiles in tqdm(
+ zip(
+ plindex["system_id"],
+ plindex["ligand_instance_chain"],
+ plindex["ligand_rdkit_canonical_smiles"],
+ ),
+ total=len(plindex),
+ desc="getting fingerprints",
+ ):
+ try:
+ mol = Chem.MolFromSmiles(smiles)
+ mols[system_id][ligand_instance_chain] = mol
+ fps[system_id][ligand_instance_chain] = self.fpgen.GetFingerprint(mol)
+ except Exception as e:
+ logger.info(f"Failed to get fingerprint for {system_id} due to: {e}")
+ continue
+ system_id_to_protein_chains = defaultdict(set)
+ system_id_to_ligand_instance_chain = defaultdict(set)
+ for system_id, protein_chains, ligand_instance_chain in zip(
+ plindex["system_id"],
+ plindex["system_protein_chains_auth_id"],
+ plindex["ligand_instance_chain"],
+ ):
+ system_id_to_protein_chains[system_id].update(set(protein_chains))
+ system_id_to_ligand_instance_chain[system_id].add(ligand_instance_chain)
+ score_dict = defaultdict(lambda: defaultdict(list))
+ errors = []
+ for system_1, system_2 in tqdm(system_id_pairs):
+ if system_1.split("__")[1] != "1":
+ continue
+ if (
+ system_1 not in system_id_to_protein_chains
+ or system_2 not in system_id_to_protein_chains
+ ):
+ continue
+ if (
+ system_1 not in system_id_to_ligand_instance_chain
+ or system_2 not in system_id_to_ligand_instance_chain
+ ):
+ continue
+ foldseek_results = (
+ pd.read_parquet(
+ self.db_dir / f"holo_foldseek/aln/{system_1[:4]}.parquet",
+ filters=[
+ ("target_pdb_id", "==", system_2[:4]),
+ ("query_chain", "in", system_id_to_protein_chains[system_1]),
+ ("target_chain", "in", system_id_to_protein_chains[system_2]),
+ ],
+ columns=["u", "t", "lddt"],
+ )
+ .sort_values(by="lddt", ascending=False)
+ .head(1)
+ )
+ if foldseek_results.empty:
+ continue
+ rotation = np.array(list(map(float, foldseek_results.u[0].split(","))))
+ translation = np.array(list(map(float, foldseek_results.t[0].split(","))))
+ for ligand_instance_chain_1 in system_id_to_ligand_instance_chain[system_1]:
+ key = (system_1, ligand_instance_chain_1)
+ try:
+ score_dict["tanimoto"][(key, system_2)] = [
+ max(
+ [
+ DataStructs.TanimotoSimilarity(
+ fps[system_1][ligand_instance_chain_1],
+ fps[system_2][ligand_instance_chain_2],
+ )
+ for ligand_instance_chain_2 in system_id_to_ligand_instance_chain[
+ system_2
+ ]
+ ]
+ )
+ ]
+ except Exception as e:
+ errors.append((key, system_2, "tanimoto", e))
+ for ligand_instance_chain_2 in system_id_to_ligand_instance_chain[system_2]:
+ sdf_file_1 = (
+ PLINDER_DIR
+ / "systems"
+ / system_1
+ / "ligand_files"
+ / f"{ligand_instance_chain_1}.sdf"
+ )
+ sdf_file_2 = (
+ PLINDER_DIR
+ / "systems"
+ / system_2
+ / "ligand_files"
+ / f"{ligand_instance_chain_2}.sdf"
+ )
+ if not sdf_file_1.exists() or not sdf_file_2.exists():
+ continue
+ try:
+ # ALIGN USING FOLDSEEK
+ mol_1 = Chem.MolFromMolFile(str(sdf_file_1))
+ mol_2 = Chem.MolFromMolFile(str(sdf_file_2))
+ conf = mol_2.GetConformer()
+ coords = np.array(
+ [list(conf.GetAtomPosition(i)) for i in range(mol_2.GetNumAtoms())]
+ )
+ rotated_coords = coords @ rotation.reshape(3, 3).T + translation
+ for i in range(mol_2.GetNumAtoms()):
+ conf.SetAtomPosition(i, rotated_coords[i])
+ score_dict["sucos_protein"][(key, system_2)].append(
+ get_sucos_score(mol_1, mol_2)
+ )
+ except Exception as e:
+ errors.append((key, system_2, "sucos_protein", e))
+ # ALIGN USING SHAPE
+ try:
+ mol_1 = Chem.MolFromMolFile(str(sdf_file_1))
+ mol_2 = Chem.MolFromMolFile(str(sdf_file_2))
+ except Exception:
+ try:
+ mol_1 = Chem.MolFromMolFile(
+ str(sdf_file_1), sanitize=False, strictParsing=False
+ )
+ mol_2 = Chem.MolFromMolFile(
+ str(sdf_file_2), sanitize=False, strictParsing=False
+ )
+ except Exception as e:
+ errors.append((key, system_2, "sucos_shape", e))
+ continue
+ try:
+ shape_similarity, color_similarity = align_molecules(mol_1, mol_2)
+ except Exception as e:
+ errors.append((key, system_2, "shape", e))
+ continue
+ try:
+ score_dict["sucos_shape"][(key, system_2)].append(
+ get_sucos_score(mol_1, mol_2)
+ )
+ except Exception:
+ score_dict["sucos_shape"][(key, system_2)].append(0)
+ score_dict["shape"][(key, system_2)].append(shape_similarity)
+ score_dict["color"][(key, system_2)].append(color_similarity)
+
+ dfs = []
+ for metric in score_dict:
+ df = pd.DataFrame(
+ [
+ {
+ "query_system": key[0],
+ "query_ligand_instance_chain": key[1],
+ "target_system": system_2,
+ "metric": metric,
+ "similarity": (
+ np.nanmax(score_dict[metric][(key, system_2)])
+ if len(score_dict[metric][(key, system_2)]) > 0
+ else np.nan
+ ),
+ }
+ for key, system_2 in score_dict[metric]
+ ]
+ )
+ dfs.append(df)
+ if len(dfs) > 0:
+ df = (
+ pd.concat(dfs)
+ .pivot_table(
+ index=[
+ "query_system",
+ "query_ligand_instance_chain",
+ "target_system",
+ ],
+ columns="metric",
+ values="similarity",
+ observed=False,
+ )
+ .reset_index()
+ )
+ scores_df = scores_df.pivot_table(
+ index=["query_system", "target_system"],
+ columns="metric",
+ values="similarity",
+ observed=False,
+ ).reset_index()
+ scores_df = (
+ pd.merge(scores_df, df, on=["query_system", "target_system"], how="outer")
+ .reset_index(drop=True)
+ .drop_duplicates()
+ )
+ scores_df.to_parquet(self.output_dir / f"{pdb_id}.parquet", index=False)
+ if len(errors):
+ with open(self.output_dir / f"{pdb_id}.errors", "w") as f:
+ for line in errors:
+ f.write("\t".join([str(x) for x in line]) + "\n")
+
+
+def main():
+ """Execute similarity scoring."""
+ import sys
+
+ pdb_id = sys.argv[1]
+ scorer = SimilarityScorer()
+
+ filename = DIRECTORIES["scores"] / f"holo_foldseek/aln/{pdb_id}.parquet"
+ plinder_score_file = DIRECTORIES["scores"] / f"search_db=holo/{pdb_id}.parquet"
+ output_file = DIRECTORIES["scores"] / f"scores/all_scores/{pdb_id}.parquet"
+ if filename.exists():
+ if not plinder_score_file.exists():
+ scorer.score_system_plinder(pdb_id)
+ if plinder_score_file.exists() and not output_file.exists():
+ scorer.score_system_ligand(pdb_id)
+
+
+if __name__ == "__main__":
+ main()
diff --git a/posebench/data/boltz_input_preparation.py b/posebench/data/boltz_input_preparation.py
new file mode 100644
index 00000000..df5da1ab
--- /dev/null
+++ b/posebench/data/boltz_input_preparation.py
@@ -0,0 +1,214 @@
+# -------------------------------------------------------------------------------------------------------------------------------------
+# Following code curated for PoseBench: (https://github.com/BioinfoMachineLearning/PoseBench)
+# -------------------------------------------------------------------------------------------------------------------------------------
+
+import logging
+import os
+
+import hydra
+import rootutils
+from beartype import beartype
+from beartype.typing import Any, List, Optional, Tuple
+from omegaconf import DictConfig
+
+rootutils.setup_root(__file__, indicator=".project-root", pythonpath=True)
+
+from posebench import register_custom_omegaconf_resolvers
+from posebench.utils.data_utils import (
+ extract_sequences_from_protein_structure_file,
+ parse_inference_inputs_from_dir,
+)
+
+logging.basicConfig(format="[%(asctime)s] {%(filename)s:%(lineno)d} %(levelname)s - %(message)s")
+logger = logging.getLogger(__name__)
+
+
+@beartype
+def write_scripts(
+ smiles_and_pdb_id_list: List[Tuple[Any, str]],
+ input_data_dir: str,
+ msa_dir: str | None,
+ output_scripts_path: str,
+ dataset: str,
+ pocket_only_baseline: bool = False,
+ protein_filepath: Optional[str] = None,
+ ligand_smiles: Optional[Any] = None,
+ input_id: Optional[str] = None,
+):
+ """Write a Boltz inference CSV file.
+
+ :param smiles_and_pdb_id_list: A list of tuples each containing a
+ SMILES string and a PDB ID.
+ :param input_data_dir: Path to directory of input protein-ligand
+ complex subdirectories.
+ :param msa_dir: Path to directory of MSA files.
+ :param output_scripts_path: Path to directory of output FASTA
+ sequence files.
+ :param dataset: Dataset name.
+ :param pocket_only_baseline: Whether to provide only the protein
+ pocket as a baseline experiment.
+ :param protein_filepath: Optional path to the protein structure
+ file.
+ :param ligand_smiles: Optional SMILES string of the ligand.
+ :param input_id: Optional input ID.
+ """
+ if pocket_only_baseline:
+ output_scripts_path = output_scripts_path.replace(dataset, f"{dataset}_pocket_only")
+
+ os.makedirs(output_scripts_path, exist_ok=True)
+ if protein_filepath is not None and ligand_smiles is not None:
+ input_id = (
+ "_".join(os.path.splitext(os.path.basename(protein_filepath))[0].split("_")[:2])
+ if input_id is None
+ else input_id
+ )
+ # only parse protein chains (e.g., not nucleic acids)
+ protein_sequence_list = [
+ seq
+ for seq in extract_sequences_from_protein_structure_file(protein_filepath)
+ if len(seq) > 0
+ ]
+ output_dir = os.path.join(output_scripts_path, input_id)
+ fasta_filepath = os.path.join(output_dir, f"{input_id}.fasta")
+ if os.path.exists(fasta_filepath):
+ logger.warning(
+ f"FASTA file already exists for input ID {input_id}. Skipping writing to file..."
+ )
+ return
+ for chain_index, sequence in enumerate(protein_sequence_list, start=1):
+ chain_id = chr(ord("A") + chain_index - 1)
+ msa_path = (
+ os.path.join(msa_dir, f"{input_id}_chain_{chain_index - 1}.csv")
+ if msa_dir is not None
+ else None
+ )
+ msa_suffix = msa_path if msa_path is not None else "empty"
+ with open(fasta_filepath, "a") as f:
+ f.write(f">{chain_id}|protein|{msa_suffix}\n{sequence}\n")
+ # NOTE: in the inference setting, `:` is used to separate ligand SMILES strings
+ for chain_index, smiles in enumerate(ligand_smiles.split(":"), start=1):
+ chain_id = chr(ord("A") + chain_index - 1)
+ with open(fasta_filepath, "a") as f:
+ f.write(f">{chain_id}|smiles\n{smiles}\n")
+ else:
+ for smiles_string, pdb_id in smiles_and_pdb_id_list:
+ output_dir = os.path.join(output_scripts_path, pdb_id)
+ os.makedirs(output_dir, exist_ok=True)
+ casp_dataset_requested = os.path.basename(input_data_dir) == "targets"
+ if casp_dataset_requested:
+ protein_filepath = os.path.join(input_data_dir, f"{pdb_id}_lig.pdb")
+ else:
+ if pocket_only_baseline:
+ protein_filepath = os.path.join(
+ input_data_dir,
+ f"{dataset}_holo_aligned_predicted_structures_bs_cropped",
+ f"{pdb_id}_holo_aligned_predicted_protein.pdb",
+ )
+ if not os.path.exists(protein_filepath):
+ logger.warning(
+ f"Protein structure file not found for PDB ID {pdb_id}. Skipping..."
+ )
+ continue
+ else:
+ protein_id = pdb_id.split("_")[0] if dataset == "dockgen" else pdb_id
+ protein_file_suffix = "_processed" if dataset == "dockgen" else "_protein"
+ protein_filepath = os.path.join(
+ input_data_dir, pdb_id, f"{protein_id}{protein_file_suffix}.pdb"
+ )
+ protein_sequence_list = [
+ seq
+ for seq in extract_sequences_from_protein_structure_file(protein_filepath)
+ if len(seq) > 0
+ ]
+ ligand_smiles_list = smiles_string.split(".")
+ fasta_filepath = os.path.join(output_dir, f"{pdb_id}.fasta")
+ if os.path.exists(fasta_filepath):
+ logger.warning(
+ f"FASTA file already exists for PDB ID {pdb_id}. Skipping writing to file..."
+ )
+ continue
+ same_seq_chain_mapping = {}
+ for chain_index, sequence in enumerate(protein_sequence_list, start=1):
+ if sequence not in same_seq_chain_mapping:
+ same_seq_chain_mapping[sequence] = chain_index - 1
+ chain_id = chr(ord("A") + chain_index - 1)
+ msa_path = (
+ # NOTE: for Boltz, identical protein sequences are mapped to the same (first) MSA chain ID of the same sequence
+ os.path.join(msa_dir, f"{pdb_id}_chain_{same_seq_chain_mapping[sequence]}.csv")
+ if msa_dir is not None
+ else None
+ )
+ msa_suffix = msa_path if msa_path is not None else "empty"
+ with open(fasta_filepath, "a") as f:
+ f.write(f">{chain_id}|protein|{msa_suffix}\n{sequence}\n")
+ for chain_index, sequence in enumerate(
+ ligand_smiles_list, start=len(protein_sequence_list) + 1
+ ):
+ chain_id = chr(ord("A") + chain_index - 1)
+ with open(fasta_filepath, "a") as f:
+ f.write(f">{chain_id}|smiles\n{sequence}\n")
+
+
+@hydra.main(
+ version_base="1.3",
+ config_path="../../configs/data",
+ config_name="boltz_input_preparation.yaml",
+)
+def main(cfg: DictConfig):
+ """Parse a data directory containing subdirectories of protein-ligand
+ complexes and prepare corresponding inference CSV file for the Boltz model.
+
+ :param cfg: Configuration dictionary from the hydra YAML file.
+ """
+ # load ID subset if requested
+ pdb_ids = None
+ if cfg.dataset == "posebusters_benchmark" and cfg.posebusters_ccd_ids_filepath is not None:
+ assert os.path.exists(
+ cfg.posebusters_ccd_ids_filepath
+ ), f"Invalid CCD IDs file path for PoseBusters Benchmark: {os.path.exists(cfg.posebusters_ccd_ids_filepath)}."
+ with open(cfg.posebusters_ccd_ids_filepath) as f:
+ pdb_ids = set(f.read().splitlines())
+ elif cfg.dataset == "dockgen" and cfg.dockgen_test_ids_filepath is not None:
+ assert os.path.exists(
+ cfg.dockgen_test_ids_filepath
+ ), f"Invalid test IDs file path for DockGen: {os.path.exists(cfg.dockgen_test_ids_filepath)}."
+ with open(cfg.dockgen_test_ids_filepath) as f:
+ pdb_ids = {line.replace(" ", "-") for line in f.read().splitlines()}
+ elif cfg.dataset not in ["posebusters_benchmark", "astex_diverse", "dockgen", "casp15"]:
+ raise ValueError(f"Dataset `{cfg.dataset}` not supported.")
+
+ if cfg.protein_filepath is not None and cfg.ligand_smiles is None:
+ write_scripts(
+ smiles_and_pdb_id_list=[],
+ input_data_dir=cfg.input_data_dir,
+ msa_dir=cfg.msa_dir,
+ output_scripts_path=cfg.output_scripts_path,
+ dataset=cfg.dataset,
+ pocket_only_baseline=cfg.pocket_only_baseline,
+ protein_filepath=cfg.protein_filepath,
+ ligand_smiles=cfg.ligand_smiles,
+ input_id=cfg.input_id,
+ )
+ else:
+ smiles_and_pdb_id_list = parse_inference_inputs_from_dir(
+ input_data_dir=cfg.input_data_dir,
+ pdb_ids=pdb_ids,
+ )
+ write_scripts(
+ smiles_and_pdb_id_list=smiles_and_pdb_id_list,
+ input_data_dir=cfg.input_data_dir,
+ msa_dir=cfg.msa_dir,
+ output_scripts_path=cfg.output_scripts_path,
+ dataset=cfg.dataset,
+ pocket_only_baseline=cfg.pocket_only_baseline,
+ protein_filepath=cfg.protein_filepath,
+ ligand_smiles=cfg.ligand_smiles,
+ input_id=cfg.input_id,
+ )
+
+ logger.info(f"Boltz input files for dataset `{cfg.dataset}` are fully prepared for inference.")
+
+
+if __name__ == "__main__":
+ register_custom_omegaconf_resolvers()
+ main()
diff --git a/posebench/data/boltz_output_extraction.py b/posebench/data/boltz_output_extraction.py
new file mode 100644
index 00000000..71ccdc43
--- /dev/null
+++ b/posebench/data/boltz_output_extraction.py
@@ -0,0 +1,144 @@
+# -------------------------------------------------------------------------------------------------------------------------------------
+# Following code curated for PoseBench: (https://github.com/BioinfoMachineLearning/PoseBench)
+# -------------------------------------------------------------------------------------------------------------------------------------
+
+import logging
+import os
+
+import hydra
+import numpy as np
+import rootutils
+from omegaconf import DictConfig, open_dict
+
+rootutils.setup_root(__file__, indicator=".project-root", pythonpath=True)
+
+from posebench.utils.data_utils import (
+ extract_protein_and_ligands_with_prody,
+ parse_inference_inputs_from_dir,
+)
+
+logging.basicConfig(format="[%(asctime)s] {%(filename)s:%(lineno)d} %(levelname)s - %(message)s")
+logger = logging.getLogger(__name__)
+
+
+@hydra.main(
+ version_base="1.3",
+ config_path="../../configs/data",
+ config_name="boltz_output_extraction.yaml",
+)
+def main(cfg: DictConfig):
+ """Extract proteins and ligands separately from the prediction outputs."""
+ pdb_ids = None
+ if cfg.dataset == "posebusters_benchmark" and cfg.posebusters_ccd_ids_filepath is not None:
+ assert os.path.exists(
+ cfg.posebusters_ccd_ids_filepath
+ ), f"Invalid CCD IDs file path for PoseBusters Benchmark: {os.path.exists(cfg.posebusters_ccd_ids_filepath)}."
+ with open(cfg.posebusters_ccd_ids_filepath) as f:
+ pdb_ids = set(f.read().splitlines())
+ elif cfg.dataset == "dockgen" and cfg.dockgen_test_ids_filepath is not None:
+ assert os.path.exists(
+ cfg.dockgen_test_ids_filepath
+ ), f"Invalid test IDs file path for DockGen: {os.path.exists(cfg.dockgen_test_ids_filepath)}."
+ with open(cfg.dockgen_test_ids_filepath) as f:
+ pdb_ids = {line.replace(" ", "-") for line in f.read().splitlines()}
+ elif cfg.dataset not in ["posebusters_benchmark", "astex_diverse", "dockgen", "casp15"]:
+ raise ValueError(f"Dataset `{cfg.dataset}` not supported.")
+
+ if cfg.pocket_only_baseline:
+ with open_dict(cfg):
+ cfg.prediction_inputs_dir = cfg.prediction_inputs_dir.replace(
+ cfg.dataset, f"{cfg.dataset}_pocket_only"
+ )
+ cfg.prediction_outputs_dir = cfg.prediction_outputs_dir.replace(
+ cfg.dataset, f"{cfg.dataset}_pocket_only"
+ )
+ cfg.inference_outputs_dir = cfg.inference_outputs_dir.replace(
+ f"boltz_{cfg.dataset}", f"boltz_pocket_only_{cfg.dataset}"
+ )
+
+ if cfg.complex_filepath is not None:
+ # process single-complex inputs
+ assert os.path.exists(
+ cfg.complex_filepath
+ ), f"Complex PDB file not found: {cfg.complex_filepath}"
+ assert (
+ cfg.complex_id is not None
+ ), "Complex ID must be provided when extracting single complex outputs."
+ assert (
+ cfg.ligand_smiles is not None
+ ), "Ligand SMILES must be provided when extracting single complex outputs."
+ assert (
+ cfg.output_dir is not None
+ ), "Output directory must be provided when extracting single complex outputs."
+ intermediate_output_filepath = cfg.complex_filepath
+ final_output_filepath = os.path.join(
+ cfg.output_dir, cfg.complex_id, os.path.basename(cfg.complex_filepath)
+ )
+ os.makedirs(os.path.dirname(final_output_filepath), exist_ok=True)
+ try:
+ extract_protein_and_ligands_with_prody(
+ intermediate_output_filepath,
+ final_output_filepath.replace(".cif", "_protein.pdb"),
+ final_output_filepath.replace(".cif", "_ligand.sdf"),
+ sanitize=False,
+ generify_resnames=True,
+ clear_ligand_segnames=True,
+ add_element_types=True,
+ ligand_smiles=cfg.ligand_smiles,
+ )
+ except Exception as e:
+ logger.error(f"Failed to extract protein and ligands for {cfg.complex_id} due to: {e}")
+ else:
+ # process all complexes in a dataset
+ smiles_and_pdb_id_list = parse_inference_inputs_from_dir(
+ cfg.input_data_dir,
+ pdb_ids=pdb_ids,
+ )
+ pdb_id_to_smiles = {pdb_id: smiles for smiles, pdb_id in smiles_and_pdb_id_list}
+ for item in os.listdir(cfg.prediction_inputs_dir):
+ input_item_path = os.path.join(cfg.prediction_inputs_dir, item)
+ output_item_path = os.path.join(
+ # NOTE: Boltz pre-rank orders its outputs by their aggregate score
+ cfg.prediction_outputs_dir,
+ f"boltz_results_{item}",
+ "predictions",
+ item,
+ )
+
+ if os.path.isdir(input_item_path) and os.path.isdir(output_item_path):
+ for file in os.listdir(output_item_path):
+ if not file.endswith(".cif"):
+ continue
+ intermediate_output_filepath = os.path.join(output_item_path, file)
+ final_output_filepath = os.path.join(cfg.inference_outputs_dir, item, file)
+ os.makedirs(os.path.dirname(final_output_filepath), exist_ok=True)
+
+ if cfg.dataset in ["posebusters_benchmark", "astex_diverse", "dockgen"]:
+ ligand_smiles = pdb_id_to_smiles[item]
+ else:
+ # NOTE: for the `casp15` dataset, standalone ligand SMILES are not available
+ ligand_smiles = None
+
+ try:
+ extract_protein_and_ligands_with_prody(
+ intermediate_output_filepath,
+ final_output_filepath.replace(".cif", "_protein.pdb"),
+ final_output_filepath.replace(".cif", "_ligand.sdf"),
+ sanitize=False,
+ generify_resnames=True,
+ clear_ligand_segnames=True,
+ add_element_types=True,
+ ligand_smiles=ligand_smiles,
+ )
+ except Exception as e:
+ logger.error(
+ f"Failed to extract protein and ligands for {item} due to: {e}"
+ )
+
+ logger.info(
+ f"Finished extracting {cfg.dataset} protein and ligands from all prediction outputs."
+ )
+
+
+if __name__ == "__main__":
+ main()
diff --git a/posebench/data/chai_input_preparation.py b/posebench/data/chai_input_preparation.py
index 07349e23..834bcedd 100644
--- a/posebench/data/chai_input_preparation.py
+++ b/posebench/data/chai_input_preparation.py
@@ -100,9 +100,10 @@ def write_scripts(
)
continue
else:
- dockgen_suffix = "_processed" if dataset == "dockgen" else ""
+ protein_id = pdb_id.split("_")[0] if dataset == "dockgen" else pdb_id
+ protein_file_suffix = "_processed" if dataset == "dockgen" else "_protein"
protein_filepath = os.path.join(
- input_data_dir, pdb_id, f"{pdb_id}_protein{dockgen_suffix}.pdb"
+ input_data_dir, pdb_id, f"{protein_id}{protein_file_suffix}.pdb"
)
protein_sequence_list = [
seq
diff --git a/posebench/data/components/prepare_boltz_msas.py b/posebench/data/components/prepare_boltz_msas.py
new file mode 100644
index 00000000..27574a7c
--- /dev/null
+++ b/posebench/data/components/prepare_boltz_msas.py
@@ -0,0 +1,171 @@
+# -------------------------------------------------------------------------------------------------------------------------------------
+# Following code curated for PoseBench: (https://github.com/BioinfoMachineLearning/PoseBench)
+# -------------------------------------------------------------------------------------------------------------------------------------
+
+import logging
+import os
+
+import hydra
+import numpy as np
+import pandas as pd
+import rootutils
+from omegaconf import DictConfig
+from tqdm import tqdm
+
+rootutils.setup_root(__file__, indicator=".project-root", pythonpath=True)
+# ------------------------------------------------------------------------------------ #
+# the setup_root above is equivalent to:
+# - adding project root dir to PYTHONPATH
+# (so you don't need to force user to install project as a package)
+# (necessary before importing any local modules e.g. `from posebench import utils`)
+# - setting up PROJECT_ROOT environment variable
+# (which is used as a base for paths in "configs/paths/default.yaml")
+# (this way all filepaths are the same no matter where you run the code)
+# - loading environment variables from ".env" in root dir
+#
+# you can remove it if you:
+# 1. either install project as a package or move entry files to project root dir
+# 2. set `root_dir` to "." in "configs/paths/default.yaml"
+#
+# more info: https://github.com/ashleve/rootutils
+# ------------------------------------------------------------------------------------ #
+
+from posebench.utils.data_utils import extract_sequences_from_protein_structure_file
+
+logging.basicConfig(format="[%(asctime)s] {%(filename)s:%(lineno)d} %(levelname)s - %(message)s")
+logger = logging.getLogger(__name__)
+
+
+ID_TO_HHBLITS_AA = {
+ 0: "A",
+ 1: "C", # Also U.
+ 2: "D", # Also B.
+ 3: "E", # Also Z.
+ 4: "F",
+ 5: "G",
+ 6: "H",
+ 7: "I",
+ 8: "K",
+ 9: "L",
+ 10: "M",
+ 11: "N",
+ 12: "P",
+ 13: "Q",
+ 14: "R",
+ 15: "S",
+ 16: "T",
+ 17: "V",
+ 18: "W",
+ 19: "Y",
+ 20: "X", # Includes J and O.
+ 21: "-",
+}
+
+
+@hydra.main(
+ version_base="1.3",
+ config_path="../../../configs/data/components",
+ config_name="prepare_boltz_msas.yaml",
+)
+def main(cfg: DictConfig):
+ """Prepare Boltz MSAs for PoseBench."""
+ assert os.path.exists(cfg.input_msa_dir), f"Input MSA directory not found: {cfg.input_msa_dir}"
+ os.makedirs(cfg.output_msa_dir, exist_ok=True)
+
+ for msa_file in tqdm(os.listdir(cfg.input_msa_dir), desc="Preparing Boltz MSAs"):
+ if not msa_file.endswith(".npz"):
+ continue
+
+ item = msa_file.split("_protein")[0]
+ input_msa_path = os.path.join(cfg.input_msa_dir, msa_file)
+
+ casp_dataset_requested = os.path.basename(cfg.input_data_dir) == "targets"
+ if casp_dataset_requested:
+ protein_filepath = os.path.join(cfg.input_data_dir, f"{item}_lig.pdb")
+ else:
+ if cfg.pocket_only_baseline:
+ protein_filepath = os.path.join(
+ cfg.input_data_dir,
+ f"{cfg.dataset}_holo_aligned_predicted_structures_bs_cropped",
+ f"{item}_holo_aligned_predicted_protein.pdb",
+ )
+ if not os.path.exists(protein_filepath):
+ logger.warning(
+ f"Protein structure file not found for PDB ID {item}. Skipping..."
+ )
+ continue
+ else:
+ protein_item = item.split("_")[0] if cfg.dataset == "dockgen" else item
+ protein_file_suffix = "_processed" if cfg.dataset == "dockgen" else "_protein"
+ protein_filepath = os.path.join(
+ cfg.input_data_dir, item, f"{protein_item}{protein_file_suffix}.pdb"
+ )
+ protein_sequence_list = [
+ seq
+ for seq in extract_sequences_from_protein_structure_file(protein_filepath)
+ if len(seq) > 0
+ ]
+
+ try:
+ input_msa = dict(np.load(input_msa_path))
+
+ assert (
+ len(protein_sequence_list) == input_msa["n"]
+ ), f"Number of chains in protein structure file ({len(protein_sequence_list)}) does not match number of MSA chains ({input_msa['n']}) for {item}. Skipping..."
+
+ for chain_index in range(input_msa["n"]):
+ output_msa_path = os.path.join(
+ cfg.output_msa_dir, item + f"_chain_{chain_index}.csv"
+ )
+ if os.path.exists(output_msa_path) and cfg.skip_existing:
+ logger.info(f"MSA already exists: {output_msa_path}. Skipping...")
+ continue
+
+ protein_sequence = protein_sequence_list[chain_index]
+ msa_sequence = "".join(
+ ID_TO_HHBLITS_AA[c] for c in input_msa[f"msa_{chain_index}"][0]
+ )
+
+ max_sequence_len = max(len(protein_sequence), len(msa_sequence))
+
+ if protein_sequence != msa_sequence and len(protein_sequence) == len(msa_sequence):
+ logger.warning(
+ f"Input protein sequence {protein_sequence} does not match first MSA sequence {msa_sequence} for chain {chain_index} in {item}. Using input protein sequence instead..."
+ )
+ msa_sequence = protein_sequence
+ elif protein_sequence != msa_sequence:
+ logger.warning(
+ f"Input protein sequence {protein_sequence} does not match first MSA sequence length of {msa_sequence} for chain {chain_index} in {item}. Using input protein sequence instead and right-padding rest of MSA..."
+ )
+ msa_sequence = protein_sequence
+
+ output_msas = [
+ {
+ "sequence": (
+ msa_sequence
+ if seq_index == 0
+ else "".join(ID_TO_HHBLITS_AA[c] for c in seq).rjust(
+ max_sequence_len, "-"
+ )
+ ),
+ "key": (
+ seq_index
+ if input_msa[f"is_paired_{chain_index}"][seq_index].item() is True
+ else ""
+ ),
+ }
+ for seq_index, seq in enumerate(input_msa[f"msa_{chain_index}"])
+ ]
+ output_msa_df = pd.DataFrame(output_msas)
+
+ logger.info(
+ f"Converting chain MSA to DataFrame: {input_msa_path} -> {output_msa_path}"
+ )
+ output_msa_df.to_csv(output_msa_path, index=False)
+
+ except Exception as e:
+ logger.error(f"Failed to process MSA {input_msa_path} due to: {e}. Skipping...")
+
+
+if __name__ == "__main__":
+ main()
diff --git a/posebench/data/rfaa_input_preparation.py b/posebench/data/rfaa_input_preparation.py
index 82c9cd06..47ae514f 100644
--- a/posebench/data/rfaa_input_preparation.py
+++ b/posebench/data/rfaa_input_preparation.py
@@ -110,9 +110,10 @@ def write_scripts(
)
continue
else:
- dockgen_suffix = "_processed" if dataset == "dockgen" else ""
+ protein_id = pdb_id.split("_")[0] if dataset == "dockgen" else pdb_id
+ protein_file_suffix = "_processed" if dataset == "dockgen" else "_protein"
protein_filepath = os.path.join(
- input_data_dir, pdb_id, f"{pdb_id}_protein{dockgen_suffix}.pdb"
+ input_data_dir, pdb_id, f"{protein_id}{protein_file_suffix}.pdb"
)
if dataset == "dockgen":
ligand_filepaths = [
diff --git a/posebench/models/boltz_inference.py b/posebench/models/boltz_inference.py
new file mode 100644
index 00000000..d02f565b
--- /dev/null
+++ b/posebench/models/boltz_inference.py
@@ -0,0 +1,133 @@
+# -------------------------------------------------------------------------------------------------------------------------------------
+# Following code curated for PoseBench: (https://github.com/BioinfoMachineLearning/PoseBench)
+# -------------------------------------------------------------------------------------------------------------------------------------
+
+import glob
+import logging
+import os
+import subprocess # nosec
+import traceback
+
+import hydra
+import rootutils
+from omegaconf import DictConfig, open_dict
+
+rootutils.setup_root(__file__, indicator=".project-root", pythonpath=True)
+
+from posebench import register_custom_omegaconf_resolvers
+
+logging.basicConfig(format="[%(asctime)s] {%(filename)s:%(lineno)d} %(levelname)s - %(message)s")
+logger = logging.getLogger(__name__)
+
+
+def run_boltz_inference(fasta_file: str, cfg: DictConfig):
+ """Run inference using a trained Boltz model checkpoint.
+
+ :param fasta_filepath: Path to the input FASTA file.
+ :param cfg: Configuration dictionary from the hydra YAML file.
+ """
+ assert os.path.exists(fasta_file), f"FASTA file `{fasta_file}` not found."
+ os.makedirs(cfg.output_dir, exist_ok=True)
+ try:
+ cmd = [
+ "boltz",
+ "predict",
+ fasta_file,
+ "--out_dir",
+ cfg.output_dir,
+ "--model",
+ cfg.model,
+ ]
+ if cfg.use_potentials:
+ cmd.append("--use_potentials")
+ subprocess.run(cmd, check=True) # nosec
+ except Exception as e:
+ raise e
+ logger.info(f"Boltz inference for FASTA file `{fasta_file}` complete.")
+
+
+@hydra.main(
+ version_base="1.3",
+ config_path="../../configs/model",
+ config_name="boltz_inference.yaml",
+)
+def main(cfg: DictConfig):
+ """Create SLURM job submission scripts for inference with Boltz.
+
+ :param cfg: Configuration dictionary from the hydra YAML file.
+ """
+ assert cfg.model in [
+ "boltz1",
+ "boltz2",
+ ], f"Invalid model `{cfg.model}` specified. Must be one of (`boltz1`, `boltz2`)."
+
+ with open_dict(cfg):
+ if cfg.pocket_only_baseline:
+ cfg.input_dir = cfg.input_dir.replace(cfg.dataset, f"{cfg.dataset}_pocket_only")
+ cfg.output_dir = cfg.output_dir.replace(cfg.dataset, f"{cfg.dataset}_pocket_only")
+
+ if cfg.max_num_inputs:
+ cfg.output_dir = cfg.output_dir.replace(
+ cfg.dataset, f"{cfg.dataset}_first_{cfg.max_num_inputs}"
+ )
+
+ num_dir_items_found = 0
+ for item in os.listdir(cfg.input_dir):
+ item_path = os.path.join(cfg.input_dir, item)
+ if os.path.isdir(item_path):
+ num_dir_items_found += 1
+ if cfg.max_num_inputs and num_dir_items_found > cfg.max_num_inputs:
+ logger.info(
+ f"Maximum number of input directories reached ({cfg.max_num_inputs}). Exiting inference loop."
+ )
+ break
+ if (
+ cfg.skip_existing
+ and os.path.exists(
+ os.path.join(
+ cfg.output_dir,
+ f"boltz_results_{item}",
+ "predictions",
+ item,
+ f"{item}_model_0.cif",
+ )
+ )
+ and not os.path.exists(
+ os.path.join(cfg.output_dir, f"boltz_results_{item}", "error_log.txt")
+ )
+ ):
+ logger.info(f"Skipping inference for `{item}` as output directory already exists.")
+ continue
+ fasta_filepaths = list(glob.glob(os.path.join(item_path, "*.fasta")))
+ if not fasta_filepaths:
+ logger.error(f"Failed to find all required files for item `{item}`. Skipping...")
+ continue
+ fasta_filepath = fasta_filepaths[0]
+ try:
+ run_boltz_inference(
+ fasta_file=fasta_filepath,
+ cfg=cfg,
+ )
+ if os.path.isfile(
+ os.path.join(cfg.output_dir, f"boltz_results_{item}", item, "error_log.txt")
+ ):
+ os.remove(
+ os.path.join(
+ cfg.output_dir, f"boltz_results_{item}", item, "error_log.txt"
+ )
+ )
+ except Exception as e:
+ logger.error(
+ f"Failed to run Boltz inference for item `{item}` due to: {e}. Skipping..."
+ )
+ with open(
+ os.path.join(cfg.output_dir, f"boltz_results_{item}", "error_log.txt"), "w"
+ ) as f:
+ traceback.print_exception(type(e), e, e.__traceback__, file=f)
+
+ logger.info("Boltz inference complete.")
+
+
+if __name__ == "__main__":
+ register_custom_omegaconf_resolvers()
+ main()
diff --git a/posebench/models/ensemble_generation.py b/posebench/models/ensemble_generation.py
index 997e9050..2461df4e 100644
--- a/posebench/models/ensemble_generation.py
+++ b/posebench/models/ensemble_generation.py
@@ -50,6 +50,7 @@
"flowdock",
"rfaa",
"chai-lab",
+ "boltz",
"alphafold3",
}
@@ -629,6 +630,59 @@ def create_chai_bash_script(
logger.info(f"Bash script '{output_filepath}' created successfully.")
+def create_boltz_bash_script(
+ protein_filepath: str,
+ ligand_smiles: str,
+ input_id: str,
+ cfg: DictConfig,
+ output_filepath: Optional[str] = None,
+ generate_hpc_scripts: bool = True,
+):
+ """Create a bash script to run Boltz protein-ligand complex prediction.
+
+ :param protein_filepath: Path to the input protein structure PDB
+ file.
+ :param ligand_smiles: SMILES string of the input ligand.
+ :param input_id: Input ID.
+ :param cfg: Configuration dictionary for runtime arguments.
+ :param output_filepath: Optional path to the output bash script
+ file.
+ :param generate_hpc_scripts: Whether to generate HPC scripts for
+ RoseTTAFold-All-Atom.
+ """
+
+ if output_filepath is None:
+ output_filepath = os.path.join(cfg.output_dir, input_id, f"{input_id}_rfaa_inference.sh")
+ os.makedirs(os.path.dirname(output_filepath), exist_ok=True)
+
+ bash_script_content = f"""#!/bin/bash -l
+{insert_hpc_headers(method='boltz', time_limit='0-24:00:00') if generate_hpc_scripts else 'source /home/$USER/mambaforge/etc/profile.d/conda.sh'}
+conda activate {"$project_dir/forks/boltz/boltz/" if generate_hpc_scripts else 'forks/boltz/boltz/'}
+echo "Beginning Boltz inference for input '{input_id}'!"
+
+# command to run boltz_input_preparation.py
+python posebench/data/boltz_input_preparation.py \\
+ dataset=ensemble \\
+ protein_filepath='{protein_filepath}' \\
+ ligand_smiles='"{ligand_smiles}"' \\
+ input_id='{input_id}'
+
+# command to run boltz_inference.py
+echo "Calling boltz_inference.py!"
+python posebench/models/boltz_inference.py \\
+ dataset=ensemble \\
+ cuda_device_index={cfg.cuda_device_index} \\
+ skip_existing={cfg.boltz_skip_existing}
+
+echo "Finished calling boltz_inference.py!"
+ """
+
+ with open(output_filepath, "w") as file:
+ file.write(bash_script_content)
+
+ logger.info(f"Bash script '{output_filepath}' created successfully.")
+
+
def create_vina_bash_script(
binding_site_method: Literal[
"diffdock", "fabind", "dynamicbind", "neuralplexer", "flowdock", "rfaa"
@@ -820,6 +874,15 @@ def extract_protein_chains_to_fasta_files(protein_filepath: str) -> List[str]:
output_filepath=output_filepath,
generate_hpc_scripts=generate_hpc_scripts,
)
+ elif method == "boltz":
+ create_boltz_bash_script(
+ protein_filepath=protein_filepath,
+ ligand_smiles=ligand_smiles,
+ input_id=input_id,
+ cfg=cfg,
+ output_filepath=output_filepath,
+ generate_hpc_scripts=generate_hpc_scripts,
+ )
elif method == "alphafold3":
logger.info(
"AlphaFold-3 ensemble prediction Bash scripts are not supported. Skipping script creation."
@@ -1144,6 +1207,40 @@ def get_method_predictions(
],
key=rank_key,
)[: cfg.method_top_n_to_select]
+ elif method == "boltz":
+ ensemble_benchmarking_output_dir = (
+ Path(cfg.input_dir if cfg.input_dir else cfg.boltz_out_path).parent
+ / f"boltz{single_seq_suffix}{pocket_only_suffix}_{cfg.ensemble_benchmarking_dataset}_outputs_{cfg.ensemble_benchmarking_repeat_index}"
+ if cfg.ensemble_benchmarking
+ else (cfg.input_dir if cfg.input_dir else cfg.boltz_out_path)
+ )
+ protein_output_files = sorted(
+ [
+ file
+ for file in map(
+ str,
+ Path(os.path.join(ensemble_benchmarking_output_dir, target)).rglob("*.pdb"),
+ )
+ if "model_" in os.path.basename(file)
+ and "relaxed" not in os.path.basename(file)
+ and "aligned" not in os.path.basename(file)
+ ],
+ key=rank_key,
+ )[: cfg.method_top_n_to_select]
+ ligand_output_files = sorted(
+ [
+ file
+ for file in map(
+ str,
+ Path(os.path.join(ensemble_benchmarking_output_dir, target)).rglob("*.sdf"),
+ )
+ if "model_" in os.path.basename(file)
+ and "relaxed" not in os.path.basename(file)
+ and "aligned" not in os.path.basename(file)
+ and "_LIG" not in os.path.basename(file)
+ ],
+ key=rank_key,
+ )[: cfg.method_top_n_to_select]
elif method == "alphafold3":
ensemble_benchmarking_output_dir = (
Path(cfg.input_dir if cfg.input_dir else cfg.alphafold3_out_path).parent
diff --git a/posebench/models/inference_relaxation.py b/posebench/models/inference_relaxation.py
index 331a173c..7e3481c5 100644
--- a/posebench/models/inference_relaxation.py
+++ b/posebench/models/inference_relaxation.py
@@ -75,6 +75,12 @@ def relax_inference_results(
if "model_idx_0_protein.pdb" in filepath.name
and "relaxed" not in filepath.parent.stem
]
+ elif cfg.method == "boltz":
+ protein_filepaths = [
+ filepath
+ for filepath in protein_filepaths
+ if "model_0_protein.pdb" in filepath.name and "relaxed" not in filepath.parent.stem
+ ]
elif cfg.method == "alphafold3":
protein_filepaths = [
filepath
@@ -119,6 +125,12 @@ def relax_inference_results(
if "model_idx_0_ligand.sdf" in filepath.name
and "relaxed" not in filepath.parent.stem
]
+ elif cfg.method == "boltz":
+ ligand_filepaths = [
+ filepath
+ for filepath in ligand_filepaths
+ if "model_0_ligand.sdf" in filepath.name and "relaxed" not in filepath.parent.stem
+ ]
elif cfg.method == "alphafold3":
ligand_filepaths = [
filepath
@@ -178,9 +190,9 @@ def relax_inference_results(
for ligand_filepath in ligand_filepaths
)
]
- elif cfg.method == "chai-lab" or cfg.method == "alphafold3":
+ elif cfg.method in ["chai-lab", "boltz", "alphafold3"]:
raise NotImplementedError(
- "Cannot subset `chai-lab` or `alphafold3` protein predictions at this time."
+ "Cannot subset `chai-lab`, `boltz`, or `alphafold3` protein predictions at this time."
)
else:
protein_filepaths = [
@@ -342,6 +354,17 @@ def relax_single_filepair(
protein_filepath.parent.stem,
f"{protein_filepath.stem}_relaxed.pdb",
)
+ elif cfg.method == "boltz":
+ output_filepath = Path(
+ output_file_dir,
+ ligand_filepath.parent.stem,
+ f"{ligand_filepath.stem}_relaxed.sdf",
+ )
+ protein_output_filepath = Path(
+ output_file_dir,
+ protein_filepath.parent.stem,
+ f"{protein_filepath.stem}_relaxed.pdb",
+ )
elif cfg.method == "alphafold3":
output_filepath = Path(
output_file_dir,
diff --git a/posebench/utils/data_utils.py b/posebench/utils/data_utils.py
index 0f1cfe54..e6f27fb6 100644
--- a/posebench/utils/data_utils.py
+++ b/posebench/utils/data_utils.py
@@ -1590,6 +1590,7 @@ def process_ligand_with_prody(
chain,
resnum,
sanitize: bool = True,
+ generify_resnames: bool = False,
sub_smiles: Optional[str] = None,
ligand_expo_mapping: Optional[Dict[str, Any]] = None,
) -> Chem.Mol:
@@ -1607,6 +1608,7 @@ def process_ligand_with_prody(
:param chain: chain of ligand to extract
:param resnum: residue number of ligand to extract
:param sanitize: whether to sanitize the molecule
+ :param generify_resnames: whether to generify the residue names
:param sub_smiles: optional SMILES string of the ligand molecule
:param ligand_expo_mapping: optional Ligand Expo mapping
:return: molecule with bond orders assigned
@@ -1627,6 +1629,9 @@ def process_ligand_with_prody(
else:
template = None
+ if generify_resnames:
+ sub_mol.setResnames("LIG")
+
output = StringIO()
writePDBStream(output, sub_mol)
pdb_string = output.getvalue()
@@ -1678,6 +1683,8 @@ def extract_protein_and_ligands_with_prody(
ligands_output_sdf_file: Optional[str],
sanitize: bool = True,
add_element_types: bool = False,
+ generify_resnames: bool = False,
+ clear_ligand_segnames: bool = False,
write_output_files: bool = True,
load_hetatms_as_ligands: bool = False,
ligand_smiles: Optional[str] = None,
@@ -1695,6 +1702,10 @@ def extract_protein_and_ligands_with_prody(
:param sanitize: Whether to sanitize the ligand molecules.
:param add_element_types: Whether to add element types to the
protein atoms.
+ :param generify_resnames: Whether to generify the residue names of
+ the ligand molecules (e.g., for Boltz).
+ :param clear_ligand_segnames: Whether to clear the segment names of
+ the ligand atoms (e.g., for Boltz).
:param write_output_files: Whether to write the output files.
:param load_hetatms_as_ligands: Whether to load HETATM records as
ligands if no ligands are initially found.
@@ -1712,6 +1723,9 @@ def extract_protein_and_ligands_with_prody(
logger.info(f"No ligand found in {input_pdb_file}. Returning None.")
return None
+ if clear_ligand_segnames:
+ ligand.setSegnames("")
+
if write_output_files:
assert protein_output_pdb_file is not None, "Protein output PDB file must be provided."
write_pdb_with_prody(protein, protein_output_pdb_file, add_element_types=add_element_types)
@@ -1762,6 +1776,7 @@ def extract_protein_and_ligands_with_prody(
chain,
resnum,
sanitize=sanitize,
+ generify_resnames=generify_resnames,
sub_smiles=sub_smiles,
ligand_expo_mapping=ligand_expo_mapping,
)
diff --git a/scripts/benchmark_baseline_compute_resources.py b/scripts/benchmark_baseline_compute_resources.py
index c3a121b0..dfcb38f9 100644
--- a/scripts/benchmark_baseline_compute_resources.py
+++ b/scripts/benchmark_baseline_compute_resources.py
@@ -34,9 +34,10 @@ def assemble_baseline_command(cfg: DictConfig) -> List[str]:
"flowdock",
"rfaa",
"chai-lab",
+ "boltz",
"vina",
]:
- # NOTE: When running RoseTTAFold-All-Atom (or Chai-1), the `RFAA` (`chai-lab`) Conda environment must be activated instead of the `PoseBench` environment
+ # NOTE: When running RoseTTAFold-All-Atom (or Chai-1/Boltz), the `RFAA` (`chai-lab`/`boltz`) Conda environment must be activated instead of the `PoseBench` environment
vina_suffix = f" method={cfg.vina_binding_site_method}" if cfg.method == "vina" else ""
cuda_device_suffix = (
"" if cfg.method == "vina" else f" cuda_device_index={cfg.cuda_device_index}"
diff --git a/scripts/build_inference_script.py b/scripts/build_inference_script.py
index 8343747f..c723c304 100644
--- a/scripts/build_inference_script.py
+++ b/scripts/build_inference_script.py
@@ -191,6 +191,37 @@
"python3 posebench/analysis/inference_analysis_casp.py method=chai-lab dataset=casp15 repeat_index={repeat_index} relax_protein={relax_protein}",
],
},
+ "boltz": {
+ "prepare_input": [
+ "python3 posebench/data/boltz_input_preparation.py dataset={dataset} pocket_only_baseline={pocket_only_baseline}",
+ ],
+ "run_inference": [
+ "conda activate forks/boltz/boltz/",
+ "python3 posebench/models/boltz_inference.py dataset={dataset} cuda_device_index={cuda_device_index} pocket_only_baseline={pocket_only_baseline} repeat_index={repeat_index}",
+ "conda deactivate",
+ ],
+ "extract_outputs": [
+ "python3 posebench/data/boltz_output_extraction.py dataset={dataset} pocket_only_baseline={pocket_only_baseline} repeat_index={repeat_index}",
+ ],
+ "relax": [
+ "python3 posebench/models/inference_relaxation.py method=boltz dataset={dataset} cuda_device_index={cuda_device_index} pocket_only_baseline={pocket_only_baseline} relax_protein={relax_protein} remove_initial_protein_hydrogens=true repeat_index={repeat_index}",
+ ],
+ "align_complexes": [
+ "conda activate PyMOL-PoseBench",
+ "python3 posebench/analysis/complex_alignment.py method=boltz dataset={dataset} pocket_only_baseline={pocket_only_baseline} repeat_index={repeat_index}",
+ "conda deactivate",
+ ],
+ "analyze_results": [
+ "python3 posebench/analysis/inference_analysis.py method=boltz dataset={dataset} pocket_only_baseline={pocket_only_baseline} relax_protein={relax_protein} repeat_index={repeat_index}",
+ ],
+ "assemble_casp15": [
+ "python3 posebench/models/ensemble_generation.py ensemble_methods=[boltz] ensemble_ranking_method={ensemble_ranking_method} input_csv_filepath=data/test_cases/casp15/ensemble_inputs.csv output_dir=data/test_cases/casp15/top_boltz_ensemble_predictions_{repeat_index} skip_existing=true relax_method_ligands_post_ranking=false relax_protein={relax_protein} export_file_format=casp15 export_top_n=5 combine_casp_output_files=true max_method_predictions=5 method_top_n_to_select=5 resume=true ensemble_benchmarking=true ensemble_benchmarking_dataset=casp15 cuda_device_index={cuda_device_index} ensemble_benchmarking_repeat_index={repeat_index}",
+ "python3 posebench/models/ensemble_generation.py ensemble_methods=[boltz] ensemble_ranking_method={ensemble_ranking_method} input_csv_filepath=data/test_cases/casp15/ensemble_inputs.csv output_dir=data/test_cases/casp15/top_boltz_ensemble_predictions_{repeat_index} skip_existing=true relax_method_ligands_post_ranking=true relax_protein={relax_protein} export_file_format=casp15 export_top_n=5 combine_casp_output_files=true max_method_predictions=5 method_top_n_to_select=5 resume=true ensemble_benchmarking=true ensemble_benchmarking_dataset=casp15 cuda_device_index={cuda_device_index} ensemble_benchmarking_repeat_index={repeat_index}",
+ ],
+ "analyze_casp15": [
+ "python3 posebench/analysis/inference_analysis_casp.py method=boltz dataset=casp15 repeat_index={repeat_index} relax_protein={relax_protein}",
+ ],
+ },
"alphafold3": {
"extract_outputs": [
"python3 posebench/data/af3_output_extraction.py dataset={dataset} pocket_only_baseline={pocket_only_baseline} repeat_index={repeat_index}",
@@ -278,6 +309,7 @@
"flowdock",
"rfaa",
"chai-lab",
+ "boltz",
"alphafold3",
"vina",
"tulip",
@@ -296,6 +328,7 @@
"flowdock",
"rfaa",
"chai-lab",
+ "boltz",
"alphafold3",
"vina",
"ensemble",
@@ -469,6 +502,11 @@ def build_inference_script(
if method == "chai-lab" and dataset == "casp15"
else ""
)
+ boltz_casp15_input_suffix = (
+ " input_data_dir=data/casp15_set/targets"
+ if method == "boltz" and dataset == "casp15"
+ else ""
+ )
alphafold3_casp15_input_suffix = (
" input_data_dir=data/casp15_set/targets"
if method == "alphafold3" and dataset == "casp15"
@@ -483,6 +521,7 @@ def build_inference_script(
+ neuralplexer_and_flowdock_casp15_input_suffix
+ rfaa_casp15_input_suffix
+ chai_casp15_input_suffix
+ + boltz_casp15_input_suffix
+ alphafold3_casp15_input_suffix
+ "\n"
)