Difference between revisions of "2019 DOCK tutorial 1 with PDBID 2BXF"

From Rizzo_Lab
Jump to: navigation, search
 
Line 559: Line 559:
  
 
[[File:2BXFfootprint.png|thumb|center|600px| Flexible docking results for 2BXF]]
 
[[File:2BXFfootprint.png|thumb|center|600px| Flexible docking results for 2BXF]]
 
=VI.Virtual Screen=
 
The virtual screen method is a method to evaluate a large library of ligands and attempts to dock them into the same protein structure to form a protein-ligand complex. These compounds are then ranking by a variety of scoring methods such as Grid-Score, tanimoto, and pharmacophore.
 
 
The first step is to create an empty input file that is used to perform the virtual screen
 
 
touch -i virtual.in
 
 
To actually create the docking input file, use the dock6 command to input this command.
 
 
dock6 -i virtual.in
 
 
Input the following commands
 
 
conformer_search_type                                        flex
 
write_fragment_libraries                                    no
 
user_specified_anchor                                        no
 
limit_max_anchors                                            no
 
min_anchor_size                                              5
 
pruning_use_clustering                                      yes
 
pruning_max_orients                                          1000
 
pruning_clustering_cutoff                                    100
 
pruning_conformer_score_cutoff                              100.0
 
pruning_conformer_score_scaling_factor                      1.0
 
use_clash_overlap                                            no
 
write_growth_tree                                            no
 
use_internal_energy                                          yes
 
internal_energy_rep_exp                                      12
 
internal_energy_cutoff                                      100.0
 
ligand_atom_file                                            ../VS_library_5K.mol2
 
limit_max_ligands                                            no
 
skip_molecule                                                no
 
read_mol_solvation                                          no
 
calculate_rmsd                                              no
 
use_database_filter                                          no
 
orient_ligand                                                yes
 
automated_matching                                          yes
 
receptor_site_file                                          ../2.surface_spheres/2GQG_rec.sph
 
max_orientations                                            1000
 
critical_points                                              no
 
chemical_matching                                            no
 
use_ligand_spheres                                          no
 
bump_filter                                                  no
 
score_molecules                                              yes
 
contact_score_primary                                        no
 
contact_score_secondary                                      no
 
grid_score_primary                                          yes
 
grid_score_secondary                                        no
 
grid_score_rep_rad_scale                                    1
 
grid_score_vdw_scale                                        1
 
grid_score_es_scale                                          1
 
grid_score_grid_prefix                                      ../3.gridbox/Steves_grid/grid2
 
multigrid_score_secondary                                    no
 
dock3.5_score_secondary                                      no
 
continuous_score_secondary                                  no
 
footprint_similarity_score_secondary                        no
 
pharmacophore_score_secondary                                no
 
descriptor_score_secondary                                  no
 
gbsa_zou_score_secondary                                    no
 
gbsa_hawkins_score_secondary                                no
 
SASA_score_secondary                                        no
 
amber_score_secondary                                        no
 
minimize_ligand                                              yes
 
minimize_anchor                                              yes
 
minimize_flexible_growth                                    yes
 
use_advanced_simplex_parameters                              no
 
simplex_max_cycles                                          1
 
simplex_score_converge                                      0.1
 
simplex_cycle_converge                                      1.0
 
simplex_trans_step                                          1.0
 
simplex_rot_step                                            0.1
 
simplex_tors_step                                            10.0
 
simplex_anchor_max_iterations                                500
 
simplex_grow_max_iterations                                  500
 
simplex_grow_tors_premin_iterations                          0
 
simplex_random_seed                                          0
 
simplex_restraint_min                                        no
 
atom_model                                                  all
 
vdw_defn_file                                                /gpfs/projects/rizzo/zzz.programs/dock6.9_release/parameters/vdw_AMBER_parm99.defn
 
flex_defn_file                                              /gpfs/projects/rizzo/zzz.programs/dock6.9_release/parameters/flex.defn
 
flex_drive_file                                              /gpfs/projects/rizzo/zzz.programs/dock6.9_release/parameters/flex_drive.tbl
 
ligand_outfile_prefix                                        virtual_2GQG
 
write_orientations                                          no
 
num_scored_conformers                                        1
 
rank_ligands                                                no
 
 
This docking simulation runs will be performed for 25000 molecules and many simulations commonly use many more molecules so an mpi, message passing interface is used to work across multiple processors to speed up this process.
 
 
=VII.Virtual Screen MPI=
 
 
This mpi will allow you to run through the virtual screen across multiple processors
 
 
First create vim into your software
 
 
vim virtual.sh
 
 
Next input the following into the file
 
 
#!/bin/bash
 
#SBATCH --time=48:00:00
 
#SBATCH --nodes=4:ppn=28
 
#SBATCH --ntasks=24
 
#SBATCH --job-name=2GQG_VS_min
 
#SBATCH --output=2GQG_VS_min
 
#SBATCH -p rn-long
 
 
cd $SLURM_SUBMIT_DIR
 
dock6 -i virtual.in -o virtual.out
 
 
To submit the experiment to slurm submit the following command
 
 
qsub virtual.sh
 
 
 
=VIII.Cartesian Minimization=
 
 
Create empty input file for minimization
 
 
touch min.in
 
 
Use the dock6 program to generate the parameters for the input file
 
 
dock6 -i min.in
 
 
Input the following commands
 
 
conformer_search_type                                        rigid
 
use_internal_energy                                          yes
 
internal_energy_rep_exp                                      12
 
internal_energy_cutoff                                      100.0
 
ligand_atom_file                                            ../6.virtual_screen/virtual_2GQG_scored.mol2
 
limit_max_ligands                                            no
 
skip_molecule                                                no
 
read_mol_solvation                                          no
 
calculate_rmsd                                              no
 
use_database_filter                                          no
 
orient_ligand                                                no
 
bump_filter                                                  no
 
score_molecules                                              yes
 
contact_score_primary                                        no
 
contact_score_secondary                                      no
 
grid_score_primary                                          no
 
grid_score_secondary                                        no
 
multigrid_score_primary                                      no
 
multigrid_score_secondary                                    no
 
dock3.5_score_primary                                        no
 
dock3.5_score_secondary                                      no
 
continuous_score_primary                                    yes
 
continuous_score_secondary                                  no
 
cont_score_rec_filename                                      ../1.dockprep/2gqg_chainA_rec_only_modified_5.mol2
 
cont_score_att_exp                                          6
 
cont_score_rep_exp                                          12
 
cont_score_rep_rad_scale                                    1
 
cont_score_use_dist_dep_dielectric                          yes
 
cont_score_dielectric                                        4.0
 
cont_score_vdw_scale                                        1
 
cont_score_es_scale                                          1
 
footprint_similarity_score_secondary                        no
 
pharmacophore_score_secondary                                no
 
descriptor_score_secondary                                  no
 
gbsa_zou_score_secondary                                    no
 
gbsa_hawkins_score_secondary                                no
 
SASA_score_secondary                                        no
 
amber_score_secondary                                        no
 
minimize_ligand                                              yes
 
simplex_max_iterations                                      1000
 
simplex_tors_premin_iterations                              0
 
simplex_max_cycles                                          1
 
simplex_score_converge                                      0.1
 
simplex_cycle_converge                                      1.0
 
simplex_trans_step                                          1.0
 
simplex_rot_step                                            0.1
 
simplex_tors_step                                            10.0
 
simplex_random_seed                                          0
 
simplex_restraint_min                                        no
 
atom_model                                                  all
 
vdw_defn_file                                                /gpfs/projects/AMS536/zzz.programs/dock6.9_release/parameters/vdw_AMBER_parm99.defn
 
flex_defn_file                                              /gpfs/projects/AMS536/zzz.programs/dock6.9_release/parameters/flex.defn
 
flex_drive_file                                              /gpfs/projects/AMS536/zzz.programs/dock6.9_release/parameters/flex_drive.tbl
 
ligand_outfile_prefix                                        2GQG.virtualscreen.minimized
 
write_orientations                                          no
 
num_scored_conformers                                        1
 
rank_ligands                                                no
 
 
submit this minimization to the slurm docking program to minimize.
 
 
create the minimization submit script
 
 
touch min.sh
 
 
#!/bin/bash
 
#SBATCH --time=48:00:00
 
#SBATCH --nodes=1
 
#SBATCH --ntasks=24
 
#SBATCH --job-name=2GQG_VS_min
 
#SBATCH --output=2GQG_VS_min
 
#SBATCH -p rn-long
 
 
cd $SLURM_SUBMIT_DIR
 
dock6 -i min.in -o min.out
 
 
==IX.Rescoring Docked Molecules==
 
 
For this experiment, further evaluation of this program will be studied
 
 
touch rescore.in
 
 
dock6 -i rescore.in
 
 
conformer_search_type                                        rigid
 
use_internal_energy                                          yes
 
internal_energy_rep_exp                                      12
 
internal_energy_cutoff                                      100.0
 
ligand_atom_file                                            ../6.virtual_screen/virtual_2GQG_scored.mol2
 
limit_max_ligands                                            no
 
skip_molecule                                                no
 
read_mol_solvation                                          no
 
calculate_rmsd                                              no
 
use_database_filter                                          no
 
orient_ligand                                                no
 
bump_filter                                                  no
 
score_molecules                                              yes
 
contact_score_primary                                        no
 
contact_score_secondary                                      no
 
grid_score_primary                                          no
 
grid_score_secondary                                        no
 
multigrid_score_primary                                      no
 
multigrid_score_secondary                                    no
 
dock3.5_score_primary                                        no
 
dock3.5_score_secondary                                      no
 
continuous_score_primary                                    no
 
continuous_score_secondary                                  no
 
footprint_similarity_score_primary                          no
 
footprint_similarity_score_secondary                        no
 
pharmacophore_score_primary                                  no
 
pharmacophore_score_secondary                                no
 
descriptor_score_primary                                    yes
 
descriptor_score_secondary                                  no
 
descriptor_use_grid_score                                    no
 
descriptor_use_multigrid_score                              no
 
descriptor_use_continuous_score                              no
 
descriptor_use_footprint_similarity                          yes
 
descriptor_use_pharmacophore_score                          yes
 
descriptor_use_tanimoto                                      yes
 
descriptor_use_hungarian                                    yes
 
descriptor_use_volume_overlap                                yes
 
descriptor_fps_score_use_footprint_reference_mol2            yes
 
descriptor_fps_score_footprint_reference_mol2_filename      ../4.dock/2GQG_min_actual_scored.mol2
 
descriptor_fps_score_foot_compare_type                      Euclidean
 
descriptor_fps_score_normalize_foot                          no
 
descriptor_fps_score_foot_comp_all_residue                  yes
 
descriptor_fps_score_receptor_filename                      ../1.dockprep/2gqg_chainA_rec_only_modified_5.mol2
 
descriptor_fps_score_vdw_att_exp                            6
 
descriptor_fps_score_vdw_rep_exp                            12
 
descriptor_fps_score_vdw_rep_rad_scale                      1
 
descriptor_fps_score_use_distance_dependent_dielectric      yes
 
descriptor_fps_score_dielectric                              4.0
 
descriptor_fps_score_vdw_fp_scale                            1
 
descriptor_fps_score_es_fp_scale                            1
 
descriptor_fps_score_hb_fp_scale                            0
 
descriptor_fms_score_use_ref_mol2                            yes
 
descriptor_fms_score_ref_mol2_filename                      ../4.dock/2GQG_flex_scored.mol2
 
descriptor_fms_score_write_reference_pharmacophore_mol2      no
 
descriptor_fms_score_write_reference_pharmacophore_txt      no
 
descriptor_fms_score_write_candidate_pharmacophore          no
 
descriptor_fms_score_write_matched_pharmacophore            no
 
descriptor_fms_score_compare_type                            overlap
 
descriptor_fms_score_full_match                              yes
 
descriptor_fms_score_match_rate_weight                      5.0
 
descriptor_fms_score_match_dist_cutoff                      1.0
 
descriptor_fms_score_match_proj_cutoff                      0.7071
 
descriptor_fms_score_max_score                              20
 
descriptor_fingerprint_ref_filename                          ../4.dock/2GQG_flex_scored.mol2
 
descriptor_hms_score_ref_filename                            ../4.dock/2GQG_flex_scored.mol2
 
descriptor_hms_score_matching_coeff                          -5
 
descriptor_hms_score_rmsd_coeff                              1
 
descriptor_volume_score_reference_mol2_filename              ../4.dock/2GQG_flex_scored.mol2
 
descriptor_volume_score_overlap_compute_method              analytical
 
descriptor_weight_fps_score                                  1
 
descriptor_weight_pharmacophore_score                        1
 
descriptor_weight_fingerprint_tanimoto                      -1
 
descriptor_weight_hms_score                                  1
 
descriptor_weight_volume_overlap_score                      -1
 
gbsa_zou_score_secondary                                    no
 
gbsa_hawkins_score_secondary                                no
 
SASA_score_secondary                                        no
 
amber_score_secondary                                        no
 
minimize_ligand                                              no
 
atom_model                                                  all
 
vdw_defn_file                                                /gpfs/projects/rizzo/zzz.programs/dock6.9_release/parameters/vdw_AMBER_parm99.defn
 
flex_defn_file                                              /gpfs/projects/rizzo/zzz.programs/dock6.9_release/parameters/flex.defn
 
flex_drive_file                                              /gpfs/projects/rizzo/zzz.programs/dock6.9_release/parameters/flex_drive.tbl
 
chem_defn_file                                              /gpfs/projects/rizzo/zzz.programs/dock6.9_release/parameters/chem.defn
 
pharmacophore_defn_file                                      /gpfs/projects/rizzo/zzz.programs/dock6.9_release/parameters/ph4.defn
 
ligand_outfile_prefix                                        2GQG.descriptor.output
 
write_footprints                                            yes
 
write_hbonds                                                yes
 
write_orientations                                          no
 
num_scored_conformers                                        1
 
rank_ligands                                                no
 

Latest revision as of 13:35, 9 March 2020

This tutorial contains a step by step approach to dock a known ligand to a known receptor.

I. Introduction

DOCK

DOCK is a molecular docking software that was originally developed at UCSF by Dr. Irwin Kuntz, Dr. Brian Shoicket, and colleagues. DOCK is used in drug discovery and molecular modeling. It consists of 2 main components: a search algorithm to explore chemical space for conformations and a scoring function to rank the results.

2BXF

The tutorial will be based on the PDB file 2BXF downloaded from the PDB Database. 2BXF is the crystal structure for human serum albumin complexed with diazepam.

Organization of Directories

We set up the files in our project space as such. It will be helpful to have these folders ready ahead of time.

             0.files
             1.dockprep
             2.surface_spheres
             3.gridbox
             4.dock
             6.footprint
             7.virtual_screen
             8.virtual_screen_mpi
             9.cartesianmin
             10.rescore

II. Preparation of the ligand and receptor

Download the pdb file 2BXF from Protein Data Bank and save the file in the 0.files folder.

Checking the Structure and Preparing the Complex without Hydrogens

- Open Chimera, open the downloaded pdb file, and check the structure for missing residues, gaps, heme groups, missing loops, and size. We recommend using proteins with no heme groups and proteins of a relatively smaller size. 2BXF did not have any of the preceding potential problems. 

- Save the PDB file (the ligand and the receptor) as a mol2 file (2BXF_complex_noH.mol2) - When preparing both the ligand the receptor, you can open this complex mol2 file and delete the component that you won't need (eg. for preparing the receptor, open the complex, delete the ligand, and save).

Preparation of Receptor without Hydrogens

 - Open 2BXF_complex_noH.mol2 through Chimera
 - Isolate the receptor by deleting the ligand. Click on the ligand and delete it (Actions -> Atoms/Bonds -> Delete). 
 - Save the isolated receptor as a mol2 file (File -> Save mol2 -> 2BXF_rec_noH_mol2)

This receptor has been prepared without Hydrogens.

Preparation of Ligand without Hydrogens

 - Open 2BXF_complex_noH.mol2 through Chimera again
 - Isolate the ligand by deleting the receptor. Click on the receptor and delete it (Actions -> Atoms/Bonds -> Delete). 
 - Save the isolated ligand as a mol2 file (File -> Save mol2 -> 2BXF_lig_noH_mol2)

This ligand has been prepared without Hydrogens.

Preparation of receptor with Hydrogens

Preparation of ligand with Hydrogens

-Open the 2BXF_lig_noH.mol2 -Tools -> Surface Binding Analysis

          Tools -> Structure Editing -> Add H (To add Hydrogen atoms)
          Tools -> Structure Editing -> Add Charge (To add the charge use the latest AMBER force filed available for standard residues. Here we used AMBER ff14SB)
          Save as a mol2 file. (2nnq_rec_withH.mol2)
 - If you follow the step below all the above stated steps will automatically appear one after the other to prepare the receptor. 
          Tools -> Structure/Binding Analysis -> DockPrep

Preparation of ligand

 - Open the PDB file via Chimera.
 - Using Chimera, isolate the ligand, add H atoms, add charge and save it as a mol2 file by following the same steps followed for the receptor.

Once all the files are prepared make sure to save the files in 1.dockprep folder.

III. Generating receptor surface and spheres

Preparation of DMS file

 - Open 2BXF_rec_noH.mol2 using chimera.
 - Action -> Surface -> Show
 - Tools -> Structure Editing -> Write DMS
 - Save the 2BXF_rec_noH.dms into 3.surface_spheres folder

Reopen the file and make sure the surface was generated.

Transfer all the folders created so far to seawulf cluster to be used in DOCK.

Generating spheres

 - Go to 2.surface_spheres folder
 - Create a new input file to create spheres by typing vim INSPH and type the following lines inside the file. 
2BXF_rec_noH.dms
R
X
0.0
4.0
1.4
2BXF_rec.sph

The first line 2BXF_rec_noH.dms specifies the input file. R indicates that spheres generated will be outside of the receptor surface. X specifies all the points will be used. 0.0 is the distance in angstroms and it will avoid steric clashes. 4.0 is the maximum surface radius of the spheres and 1.4 is the minimum radius in angstroms.The last line 2BXF_spheres.sph creates the sph file that contains clustered spheres.

Once the INSPH file is ready, type the following command to generate the spheres.

 sphgen -i INSPH -o OUTSPH

Once sphgen command is successful, 2BXF_spheres.sph file will be created. Open it up using Chimera along with 2BXF_rec_noH.mol2 file. You should get a similar output like the image below.

2BXF receptor sphere

Selecting Spheres

Here we will be selecting the spheres which defines the binding pocket of the ligand because we are trying to direct the ligand towards that binding site rather than all over the receptor. To select the spheres type the following command.

 sphere_selector 2BXF_rec.sph ../1.dockprep/2BXF_lig_withH.mol2 10.0

This command will select all of the spheres within 10.0 angstroms of the ligand and output them to selected_spheres.sph. Visualize the selected spheres using Chimera to make sure the correct spheres are selected. Notice that, spheres around the ligand binding site are kept and all the other spheres are deleted in the image below.

2nnq receptor and selected spheres

IV. Generating box and grid

Generating box

Move to 3.boxgrid directory Create a new file showbox.in and write the following lines in the file.

 Y
 8.0
 ../2.surface_spheres/selected_spheres.sph
 1
 2BXF.box.pdb

Each of the above lines indicate that;

 We intend to generate a box
 The box length should be 8 Angstroms
 Use the selected_spheres file in the designated location
 The name of the file that contains generated box.

Use the following command to generate the box.

 showbox < showbox.in

If this step is successful, you should see a new file (2BXF.box.pdb) in 3.boxgrid folder.

Generating grid

Create a new file (grid.in)

Use the following command to generate the grid.

 grid -i grid.in -o gridinfo.out

Answer the prompted questions with the answers given below. (or you can use the following lines and include them in the grid.in file before entering the above command. If you do that these questions won't be prompted again. They will be automatically answered by grid.in file created)

compute_grids                             yes
grid_spacing                              0.4
output_molecule                           no
contact_score                             no
energy_score                              yes
energy_cutoff_distance                    9999
atom_model                                a
attractive_exponent                       6
repulsive_exponent                        9
distance_dielectric                       yes
dielectric_factor                         4
bump_filter                               yes
bump_overlap                              0.75
receptor_file                             ../1.dockprep/2BXF_rec_withH.mol2
box_file                                  2BXF.box.pdb
vdw_definition_file                       /gpfs/projects/AMS536/zzz.programs/dock6/parameters/vdw_AMBER_parm99.defn
score_grid_prefix                         grid

If the command is successful, three new files will be generated. (gridinfo.out, grid.nrg, grid.bmp). Go through gridinfo.out file to make sure all the information about the receptor in the file matches with the original information of the receptor. (Eg:- Total charge, residues and their charges) If the information doesn't match, that means you have made an error in one of the steps that you followed so far.

V. Docking a single molecule for pose reproduction

Under this section, the ligand for 2BXF.pdb will be re-docked into the receptor. 3 Methods will be used to achieve this.

1. rigid docking

2. fixed anchor docking

3. flexible docking

Energy minimization

Before performing docking, here the ligand will be subjected to energy minimization in order to remove unfavorable clashes. These clashes will affect rigid docking because in rigid docking the ligand will be docked as the complete ligand, whereas in other docking methods the ligand will be broken into fragments and the ligand will be built step by step considering favorable orientations and torsion angles after each fragment addition.

Go to the directory 4.dock and a create a new file (min.in) and enter the command below.

 dock6 -i min.in -o min.out

Answer the prompted questions using the answers given below or include the following lines in the min.in file at before entering the above command to avoid answering the questions manually.

conformer_search_type                                        rigid
use_internal_energy                                          yes
internal_energy_rep_exp                                      12
internal_energy_cutoff                                       100.0
ligand_atom_file                                             ../1.dockprep/2BXF_lig_withH.mol2
limit_max_ligands                                            no
skip_molecule                                                no
read_mol_solvation                                           no
calculate_rmsd                                               yes
use_rmsd_reference_mol                                 yes     
rmsd_reference_filename                                 ../1.dockprep/2BXF_lig_withH.mol2
use_database_filter                                          no
orient_ligand                                                no
bump_filter                                                  no
score_molecules                                              yes
contact_score_primary                                        no
contact_score_secondary                                      no
grid_score_primary                                           yes
grid_score_secondary                                         no
grid_score_rep_rad_scale                                     1
grid_score_vdw_scale                                         1
grid_score_es_scale                                          1
grid_score_grid_prefix                                       ../3.boxgrid/grid
multigrid_score_secondary                                    no
dock3.5_score_secondary                                      no
continuous_score_secondary                                   no
footprint_similarity_score_secondary                         no
pharmacophore_score_secondary                                no
descriptor_score_secondary                                   no
gbsa_zou_score_secondary                                     no
gbsa_hawkins_score_secondary                                 no
SASA_score_secondary                                         no
amber_score_secondary                                        no
minimize_ligand                                              yes
simplex_max_iterations                                       1000
simplex_tors_premin_iterations                               0
simplex_max_cycles                                           1
simplex_score_converge                                       0.1
simplex_cycle_converge                                       1.0
simplex_trans_step                                           1.0
simplex_rot_step                                             0.1
simplex_tors_step                                            10.0
simplex_random_seed                                          0
simplex_restraint_min                                        yes
simplex_coefficient_restraint                                10.0
atom_model                                                   all
vdw_defn_file                                                /gpfs/projects/AMS536/zzz.programs/dock6/parameters/vdw_AMBER_parm99.defn
flex_defn_file                                               /gpfs/projects/AMS536/zzz.programs/dock6/parameters/flex.defn
flex_drive_file                                              /gpfs/projects/AMS536/zzz.programs/dock6/parameters/flex_drive.tbl
ligand_outfile_prefix                                        2BXF.lig.min
write_orientations                                           no
num_scored_conformers                                        1
rank_ligands                                                 no 

If the process is successful a new file (2BXF.lig.min_scored.mol2) will be generated. You can compare how is it changed from the initial structure by analyzing the RMSD value generated in the file. Visualize the new mol2 file along with receptor and the initial ligand mol2 files using Chimera to see the differences.

2BXF_receptor with the original ligand and the minimized ligand

Rigid Docking

Create an input file for rigid docking

touch rigid.in

Run dock using the created input file.

dock6 -i rigid.in -o rigid.out

Follow a similar approach as we did for minimization to answer the prompted questions by either answering them manually using the answers in the lines below or by including the following lines in the input file before running dock.

conformer_search_type                                        rigid
use_internal_energy                                          yes
ligand_atom_file                                             2BXF.lig.min_scored.mol2
limit_max_ligands                                            no
skip_molecule                                                no
read_mol_solvation                                           no
calculate_rmsd                                               yes
use_rmsd_reference_mol                                 yes      
rmsd_reference_filename                                  2BXF.lig.min_scored.mol2
use_database_filter                                          no
orient_ligand                                                yes
automated_matching                                           yes
receptor_site_file                                           ../2.surface_spheres/selected_spheres.sph
max_orientations                                             1000
critical_points                                              no
chemical_matching                                            no
use_ligand_spheres                                           no
bump_filter                                                  no
score_molecules                                              yes
contact_score_primary                                        no
contact_score_secondary                                      no
grid_score_primary                                           yes
grid_score_secondary                                         no
grid_score_rep_rad_scale                                     1
grid_score_vdw_scale                                         1
grid_score_es_scale                                          1
grid_score_grid_prefix                                       ../3.boxgrid/grid
multigrid_score_secondary                                    no
dock3.5_score_secondary                                      no
continuous_score_secondary                                   no
footprint_similarity_score_secondary                         no
pharmacophore_score_secondary                                no
descriptor_score_secondary                                   no
gbsa_zou_score_secondary                                     no
gbsa_hawkins_score_secondary                                 no
SASA_score_secondary                                         no
amber_score_secondary                                        no
minimize_ligand                                              yes
simplex_max_iterations                                       1000
simplex_tors_premin_iterations                               0
simplex_max_cycles                                           1
simplex_score_converge                                       0.1
simplex_cycle_converge                                       1.0
simplex_trans_step                                           1.0
simplex_rot_step                                             0.1
simplex_tors_step                                            10.0
simplex_random_seed                                          0
simplex_restraint_min                                        no
atom_model                                                   all
vdw_defn_file                                                /gpfs/projects/AMS536/zzz.programs/dock6/parameters/vdw_AMBER_parm99.defn
flex_defn_file                                               /gpfs/projects/AMS536/zzz.programs/dock6/parameters/flex.defn
flex_drive_file                                              /gpfs/projects/AMS536/zzz.programs/dock6/parameters/flex_drive.tbl
ligand_outfile_prefix                                        rigid.out
write_orientations                                           no
num_scored_conformers                                        1
rank_ligands                                                 no

Once rigid docking is successful, you will get an output file. (rigid.out_scored.mol2) Visualize the output file using Chimera by following steps to check the rigid docking success.

Open Chimera
File -> Open -> 2BXF_rec_withH.mol2
File -> Open -> 2BXF_lig_withH.mol2
Tools -> Surface/binding Analysis -> ViewDock -> Select the Rigid Dock output file. (rigid.out_scored.mol2)
In the loaded dialog box select Dock4,5 or 6

Once everything is loaded go to the ViewDock window and use it's menu to view all the calculated properties regarding the rigid docked ligand by following the steps below.

Column -> Show -> gridscore
Column -> Show -> HA_RMSDs
Follow the same steps to get all the properties

Your visualized structure should be similar to the image below.

Rigid docking results for 2BXF

Fixed Anchor Docking

Create an input file for fixed anchor docking.

touch fixed.in

Use the input file to perform fixed anchor docking

dock6 -i fixed.in

Use the following lines to answer the prompted questions as we did in rigid docking.

conformer_search_type                                        flex
user_specified_anchor                                        no
limit_max_anchors                                            no
min_anchor_size                                              5
pruning_use_clustering                                       yes
pruning_max_orients                                          1000
pruning_clustering_cutoff                                    100
pruning_conformer_score_cutoff                               100.0
pruning_conformer_score_scaling_factor                       1.0
use_clash_overlap                                            no
write_growth_tree                                            no
write_fragment_libraries                                     no
use_internal_energy                                          yes
internal_energy_rep_exp                                      12
internal_energy_cutoff                                       100.0
ligand_atom_file                                             ../1.dockprep/2BXF_lig_withH.mol2
limit_max_ligands                                            no
skip_molecule                                                no
read_mol_solvation                                           no
calculate_rmsd                                               yes
use_rmsd_reference_mol                                       yes
rmsd_reference_filename                                      ../1.dockprep/2BXF_lig_withH.mol2
use_database_filter                                          no
orient_ligand                                                no
bump_filter                                                  no
score_molecules                                              yes
contact_score_primary                                        no
contact_score_secondary                                      no
grid_score_primary                                           yes
grid_score_secondary                                         no
grid_score_rep_rad_scale                                     1
grid_score_vdw_scale                                         1
grid_score_es_scale                                          1
grid_score_grid_prefix                                       ../2.boxgrid/grid
multigrid_score_secondary                                    no
dock3.5_score_secondary                                      no
continuous_score_secondary                                   no
footprint_similarity_score_secondary                         no
pharmacophore_score_secondary                                no
descriptor_score_secondary                                   no
gbsa_zou_score_secondary                                     no
gbsa_hawkins_score_secondary                                 no
SASA_score_secondary                                         no
amber_score_secondary                                        no
minimize_ligand                                              yes
minimize_anchor                                              yes
minimize_flexible_growth                                     yes
use_advanced_simplex_parameters                              no
simplex_max_cycles                                           1
simplex_score_converge                                       0.1
simplex_cycle_converge                                       1.0
simplex_trans_step                                           1.0
simplex_rot_step                                             0.1
simplex_tors_step                                            10.0
simplex_anchor_max_iterations                                500
simplex_grow_max_iterations                                  500
simplex_grow_tors_premin_iterations                          0
simplex_random_seed                                          0
simplex_restraint_min                                        no
atom_model                                                   all
vdw_defn_file                                                /gpfs/projects/AMS536/zzz.programs/dock6/parameters/vdw_AMBER_parm99.defn
flex_defn_file                                               /gpfs/projects/AMS536/zzz.programs/dock6/parameters/flex.defn
flex_drive_file                                              /gpfs/projects/AMS536/zzz.programs/dock6/parameters/flex_drive.tbl
ligand_outfile_prefix                                        2BXF_fad
write_orientations                                           no
num_scored_conformers                                        100
write_conformations                                          no
cluster_conformations                                        yes
cluster_rmsd_threshold                                       2.0
rank_ligands                                                 no

Once docking is completed an output file will be generated. (2BXF_fad_scored.mol2) Follow the same method used in rigid docking to visualize the docked poses using Chimera. Once it is visualized, it should like the image below. Notice all the poses 50 generated are in the same cluster and standard RMSD is 0.75. These indicate that docking is very successful.

Poses generated for fixed anchor docking

Flexible Docking

Create a new input file for flexible docking. (flex.in)

touch flex.in

Use the created input file to perform flexible docking using DOCK6.

dock6 -i flex.in -o flex.out

Answer the prompted questions using the following lines as we did in rigid and fixed anchor docking.

conformer_search_type                                        flex
user_specified_anchor                                        no
limit_max_anchors                                            no
min_anchor_size                                              5
pruning_use_clustering                                       yes
pruning_max_orients                                          1000
pruning_clustering_cutoff                                    100
pruning_conformer_score_cutoff                               100.0
pruning_conformer_score_scaling_factor                       1.0
use_clash_overlap                                            no
write_growth_tree                                            no
write_fragment_libraries                                     no
use_internal_energy                                          yes
internal_energy_rep_exp                                      12
internal_energy_cutoff                                       100.0
ligand_atom_file                                             2BXF.lig.min_scored.mol2
limit_max_ligands                                            no
skip_molecule                                                no
read_mol_solvation                                           no
calculate_rmsd                                               yes
use_rmsd_reference_mol                                yes       
rmsd_reference_filename                                2BXF.lig.min_scored.mol2
use_database_filter                                          no
orient_ligand                                                yes
automated_matching                                           yes
receptor_site_file                                           ../2.surface_spheres/selected_spheres.sph
max_orientations                                             1000
critical_points                                              no
chemical_matching                                            no
use_ligand_spheres                                           no
bump_filter                                                  no
score_molecules                                              yes
contact_score_primary                                        no
contact_score_secondary                                      no
grid_score_primary                                           yes
grid_score_secondary                                         no
grid_score_rep_rad_scale                                     1
grid_score_vdw_scale                                         1
grid_score_es_scale                                          1
grid_score_grid_prefix                                       ../3.boxgrid/grid
multigrid_score_secondary                                    no
dock3.5_score_secondary                                      no
continuous_score_secondary                                   no
footprint_similarity_score_secondary                         no
pharmacophore_score_secondary                                no
descriptor_score_secondary                                   no
gbsa_zou_score_secondary                                     no
gbsa_hawkins_score_secondary                                 no
SASA_score_secondary                                         no
amber_score_secondary                                        no
minimize_ligand                                              yes
minimize_anchor                                              yes
minimize_flexible_growth                                     yes
use_advanced_simplex_parameters                              no
simplex_max_cycles                                           1
simplex_score_converge                                       0.1
simplex_cycle_converge                                       1.0
simplex_trans_step                                           1.0
simplex_rot_step                                             0.1
simplex_tors_step                                            10.0
simplex_anchor_max_iterations                                500
simplex_grow_max_iterations                                  500
simplex_grow_tors_premin_iterations                          0
simplex_random_seed                                          0
simplex_restraint_min                                        no
atom_model                                                   all
vdw_defn_file                                                /gpfs/projects/AMS536/zzz.programs/dock6/parameters/vdw_AMBER_parm99.defn
flex_defn_file                                               /gpfs/projects/AMS536/zzz.programs/dock6/parameters/flex.defn
flex_drive_file                                              /gpfs/projects/AMS536/zzz.programs/dock6/parameters/flex_drive.tbl
ligand_outfile_prefix                                        flex.out
write_orientations                                           no
num_scored_conformers                                        1
rank_ligands                                                 no


Once flexible docking is completed an output mol2 file will be generated. (flex.out_scored.mol2). Use the visualization steps used in rigid and fixed anchor docking and study the properties of the docking results.

Flexible docking results for 2BXF

Molecular Footprint

Molecular footprints can be used to determine how a ligand interacts with the receptor. Usually, the molecular footprint shows electrostatic interactions and Van der Waals interactions. Here, the molecular footprint will be used to determine how the ligand interacts with the receptor before and after minimization. To generate molecular footprints use following steps.

Go to directory 6.footprint

Generate an input file by typing;

touch footprint.in

Use DOCK6 to generate footprints

dock6 -i footprint.in

Use the following lines to answer the prompted questions.

conformer_search_type                                        rigid
use_internal_energy                                          no
ligand_atom_file                                             2BXF_lig_min.mol2
limit_max_ligands                                            no
skip_molecule                                                no
read_mol_solvation                                           no
calculate_rmsd                                               no
use_database_filter                                          no
orient_ligand                                                no
bump_filter                                                  no
score_molecules                                              yes
contact_score_primary                                        no
contact_score_secondary                                      no
grid_score_primary                                           no
grid_score_secondary                                         no
multigrid_score_primary                                      no
multigrid_score_secondary                                    no
dock3.5_score_primary                                        no
dock3.5_score_secondary                                      no
continuous_score_primary                                     no
continuous_score_secondary                                   no
footprint_similarity_score_primary                           yes
footprint_similarity_score_secondary                         no
fps_score_use_footprint_reference_mol2                       yes
fps_score_footprint_reference_mol2_filename                  2BXF_lig_with.mol2
fps_score_foot_compare_type                                  Euclidean
fps_score_normalize_foot                                     no
fps_score_foot_comp_all_residue                              yes
fps_score_receptor_filename                                  ../1.dockprep/2BXF_rec_withH.mol2
fps_score_vdw_att_exp                                        6
fps_score_vdw_rep_exp                                        12
fps_score_vdw_rep_rad_scale                                  1
fps_score_use_distance_dependent_dielectric                  yes
fps_score_dielectric                                         4.0
fps_score_vdw_fp_scale                                        1
fps_score_es_fp_scale                                        1
fps_score_hb_fp_scale                                        0
pharmacophore_score_secondary                                no
descriptor_score_secondary                                   no
gbsa_zou_score_secondary                                     no
gbsa_hawkins_score_secondary                                 no
SASA_score_secondary                                         no
amber_score_secondary                                        no
minimize_ligand                                              no
atom_model                                                   all
vdw_defn_file                                                /gpfs/projects/AMS536/zzz.programs/dock6/parameters/vdw_AMBER_parm99.defn
flex_defn_file                                               /gpfs/projects/AMS536/zzz.programs/dock6/parameters/flex.defn
flex_drive_file                                              /gpfs/projects/AMS536/zzz.programs/dock6/parameters/flex_drive.tbl
ligand_outfile_prefix                                        footprint.out
write_footprints                                             yes
write_hbonds                                                 yes
write_orientations                                           no
num_scored_conformers                                        1
rank_ligands                                                 no  

Once everything is successful these output files should be generated. (footprint.out_footprint_scored.txt, footprint.out_hbond_scored.txt, footprint.out_scored.mol2)

Use a python script to visualize the molecular footprint. The script can be accessed in the previous DOCK tutorials. Once the script is used, the molecular footprint should be similar to the image below. Notice the large deviations in energy at different amino acid residues. Those residues contribute more towards, the interaction between the ligand and therefore can be identified as important towards the binding of new ligands which can replace the original ligand in the PDB file.

File:2BXFfootprint.png
Flexible docking results for 2BXF