Ejercicio 1 3
Ejercicio 1 3
Welcome to LEaP!
(no leaprc in search path)
>source leaprc.protein.ff14SB
en tleap
laz = sequence {NGLN PHE GLY ALA GLU PRO VAL GLU GLY LYS PRO ILE CALA}
salvar la estructura en un fichero de libreria (lib) y como pdb
saveoff laz laz_lineal.lib
Creating laz_lineal.lib
Building topology.
Building atom parameters.
Checking Unit.
WARNING: The unperturbed charge of the unit: -0.999989 is not zero.
Building topology.
Building atom parameters.
Building bond parameters.
Building angle parameters.
Building proper torsion parameters.
Building improper torsion parameters.
total 39 improper torsions applied
Building H-Bond parameters.
Incorporating Non-Bonded adjustments.
Not Marking per-residue atom chain types.
Marking per-residue atom chain types.
(Residues lacking connect0/connect1 -
these don't have chain types marked:
CALA 1
NGLN 1
)
(no restraints)
Salimos de tleap
Quit
%ls –rtl
nos lista los ficheros que hemos generado
editamos pdb con vim o con joe
%vim laz_lineal.pdb
Pasamos el fichero al ordenador que usamos como terminal y lo abrimos usando pymol
Como hay problemas lo que vamos a realizar es una pequeña minimización de energía, para
relajar la molécula y que se separen las cadenas laterales.
Para ello creamos un fichero donde le vamos a decir que es lo que tiene que hacer:
mini_ini.in
Stage 1 - minimización del lazo
&cntrl
imin=1, maxcyc=1000, ncyc=500,
cut=16., rgbmax=16., igb=5, ntb=0,
ntpr=100, ntxo=1
/
Energy minimization
maxcyc The maximum number of cycles of minimization. Default = 1.
ncyc If NTMIN is 1 then the method of minimization will be switched from steepest descent to conjugate
gradient after NCYC cycles. Default 10.
dx0 The initial step length. If the initial step length is too big then will give a huge energy; however
the minimizer is smart enough to adjust itself. Default 0.01.
drms The convergence criterion for the energy gradient: minimization will halt when the root-mean-
square of the Cartesian elements of the gradient is less than DRMS. Default 1.0E-4 kcal/mole-Å
igb Flag for using the generalized Born or Poisson-Boltzmann implicit solvent models. Default is 0.
cut This is used to specify the nonbonded cutoff, in Angstroms. For PME, the cutoff is used to limit
direct space sum, and 8.0 is usually a good value. When igb>0, the cutoff is used to truncate
nonbonded pairs (on an atom-by-atom basis); here a larger value than the default is generally
required. A separate parameter (RGBMAX) controls the maximum distance between atom pairs
that will be considered in carrying out the pairwise summation involved in calculating the
effective Born radii.
When igb > 0, the default is 9999.0 (effectively infinite)
When igb==0, the default is 8.0.
The Particle Mesh Ewald (PME) method is always "on", unless ntb = 0. PME is a fast implementation of
the Ewald summation method for calculating the full electrostatic energy of a unit cell.
ntb This variable controls whether or not periodic boundaries are imposed on the system during
the calculation of non-bonded interactions. Bonds spanning periodic boundaries are not yet
supported. There is no longer any need to set this variable, since it can be determined from igb
and ntp parameters. The “proper” default for ntb is chosen (ntb=0 when igb > 0, ntb=2 when
ntp > 0, and ntb=1 otherwise). This behavior can be overridden by supplying an explicit value,
although this is discouraged to prevent errors. The allowed values for NTB are
= 0 no periodicity is applied and PME is off (default when igb > 0)
= 1 constant volume (default when igb and ntp are both 0)
= 2 constant pressure (default when ntp > 0)
Constant pressure is not used in minimization (IMIN=1)
ntpr Every ntpr steps, energy information will be printed in human-readable form to files "mdout"
and "mdinfo". "mdinfo" is closed and reopened each time, so it always contains the most
recent energy and temperature. Default 50.
ntxo Format of the final coordinates, velocities, and box size (if constant volume or pressure run)
written to file "restrt".
= 1 Formatted (ASCII)
= 2 (default) NetCDF file (recommended, unless you have a workflow that requires the formatted
form.)
Una vez creado el fichero introducimos la orden de ejecución de la simulación:
SANDER
sander [-help] [-O] [-A] -i mdin -o mdout -p prmtop -c inpcrd -r restrt
-ref refc -mtmd mtmd -x mdcrd -y inptraj -v mdvel -frc mdfrc -e mden
-inf mdinfo -radii radii -cpin cpin -cpout cpout -cprestrt cprestrt
-evbin evbin -suffix suffix
-O Overwrite output files if they exist.
-A Append output files if they exist (used mainly for replica exchange)
Ejercicio 2
De la estructura obtenida en pdb, la cargamos en pymol, le añadimos hidrógenos y la salvamos,
tendremos en este momento 190 átomos.
Este segundo ejercicio consiste en usar métodos semiempíricos para la optimización de la geometría.
Para ello vamos a utilizar el programa GAUSSIAN 09, utilizando como método semiempírico
PM3
Lo primero que hay que realizar es una conversión del fichero pdb a formato xyz, utilizamos el programa
newzmat
http://www.gaussian.com/g_tech/g_ur/u_newzmat.htm
vim min3.xyz
#PM3 Opt
-1 1
N 3.281 1.608 0.333
C 3.976 2.919 0.245
C 5.528 2.787 0.303
O 6.035 1.805 0.855
C 3.443 3.834 1.367
C 3.725 5.333 1.178
C 3.228 6.193 2.345
vim dsdna.nab
molecule m;
ejecutar nab
nab dsdna.nab
./a.out
>tleap
>source leaprc.DNA.OL15
>source leaprc.water.tip3p
dna=loadpdb “dsdna.pdb”
Minimización
Vim mindna.in
Ahora vamos a lanzar la simulación de MD, en dos situaciones distintas, una es con un cut=12A y la otra
con cut=999
Sólo vamos a analizar los primeros 100ps por tanto la simulación se ceñirá a estos.
Vim dsdna_12Acut.in
Esta simulación es a 300ºK para mantener la temperatura se activa la variable ntt y se le dá el valor 3,
con esta asignación el método que se utiliza para mantener la temperatura en equilibrio es el método
dinámico de langevin con una frecuencia de colisión dada por la variable gamma_ln
Ntb e igb son igual a cero.
Nstlim=100000, se van a realizar 100000 pasos de simulación con un tiempo para cada paso de 1fs
dt=0.001 lo que supone 100ps (100000x1fs)
Vim dsdna_nocut.in
Usando la geometría optimizada por el gaussian vamos a calentar el sistema de 0ºK a 300ºK.
Para cargar la geometría obtenida en gaussian usamos el programa Antechamber
Antechamber –L nos da una ayuda sobre los tipos de ficheros que maneja
Antechamber –help nos da una ayuda
Una vez que generamos el fichero en un formato mol2, ya que es el formato que se necesita para el
siguiente programa parmchk2, que nos genera un fichero en formato frcmod
De parámetros que incluye la modificación del campo de fuerza necesaria para leap.
calor1.in
Fase 1 Calentamiento de laz2 0 to 50K
&cntrl
imin=0, irest=0, ntx=1,
nstlim=10000, dt=0.0005,
ntc=2, ntf=2,
ntt=1, tautp=1.0,
tempi=0.0, temp0=50.0,
ntpr=50, ntwx=50, ntxo=1, ioutfm=0,
ntb=0, igb=5,
cut=16.,rgbmax=16.
/
= 1 Restart the simulation, reading coordinates and velocities from a previously saved restart
file. The velocity information is necessary when restarting, so ntx (see above) must be 4 or
higher if irest= 1
dt The time step (psec). Recommended MAXIMUM is .002 if SHAKE is used, or .001 if it isn’t. Note
that for temperatures above 300K, the step size should be reduced since greater temperatures mean
increased velocities and longer distance traveled between each force evaluation, which can lead to
anomalously high energies and system blowup. Default 0.001.
ntt Switch for temperature scaling. Note that setting ntt=0 corresponds to the microcanonical (NVE) ensemble
(which should approach the canonical one for large numbers of degrees of freedom). Some aspects of the "weak-
coupling ensemble" (ntt=1) have been examined, and roughly interpolate between the microcanonical and
canonical ensembles.[294, 295] The ntt=2 and 3 options correspond to the canonical (constant T) ensemble.
= 0 Constant total energy classical dynamics (assuming that ntb<2, as should probably always be
the case when ntt=0).
= 1 Constant temperature, using the weak-coupling algorithm.[296] A single scaling factor is
used for all atoms. Note that this algorithm just ensures that the total kinetic energy is
appropriate for the desired temperature; it does nothing to ensure that the temperature is even
over all parts of the molecule. Atomic collisions will tend to ensure an even temperature
distribution, but this is not guaranteed, and there are many subtle problems that can arise with
weak temperature coupling.[297] Using ntt=1 is especially dangerous for generalized Born
simulations, where there are no collisions with solvent to aid in thermalization.) Other
temperature coupling options (especially ntt=3) should be used instead.
= 2 Andersen temperature coupling scheme,[298] in which imaginary "collisions" randomize the
velocities to a distribution corresponding to temp0 every vrand steps. Note that in between
these "massive collisions", the dynamics is Newtonian. Hence, time correlation functions (etc.)
can be computed in these sections, and the results averaged over an initial canonical
distribution. Note also that too high a collision rate (too small a value of vrand) will slow down
the speed at which the molecules explore configuration space, whereas too low a rate means
that the canonical distribution of energies will be sampled slowly. A discussion of this rate is
given by Andersen.[299]
= 3 Use Langevin dynamics with the collision frequency g given by gamma_ln, discussed below.
Note that when g has its default value of zero, this is the same as setting ntt = 0. Since Langevin
simulations are highly susceptible to "synchronization" artifacts,[300, 301] you should explicitly
set the ig variable (described below) to a different value at each restart of a given simulation.
ntxo Format of the final coordinates, velocities, and box size (if constant volume or pressure run) written
to file "restrt".
= 1 Formatted (ASCII)
= 2 (default) NetCDF file (recommended, unless you have a workflow that requires the
formatted form.)
ntpr Every ntpr steps, energy information will be printed in human-readable form to files "mdout" and
"mdinfo". "mdinfo" is closed and reopened each time, so it always contains the most recent energy and
temperature. Default 50.
ntwx Every ntwx steps, the coordinates will be written to the mdcrd file. If ntwx = 0, no coordinate
trajectory file will be written. Default = 0.
ioutfm The format of coordinate and velocity trajectory files (mdcrd, mdvel and inptraj). As of
Amber 9, the binary format used in previous versions is no longer supported; binary
output is now in NetCDF trajectory format. Binary trajectory files have many
advantages: they are smaller, higher precision, much faster to read and write, and able
to accept a wider range of coordinate (or velocity) values than formatted trajectory files.
= 0 Formatted ASCII trajectory
= 1 (default) Binary NetCDF trajectory
temp0 Reference temperature at which the system is to be kept, if ntt > 0. Note that for temperatures
above 300K, the step size should be reduced since increased distance traveled between evaluations can
lead to SHAKE and other problems. Default 300.
tautp Time constant, in ps, for heat bath coupling for the system, if ntt = 1. Default is 1.0. Generally,
values for TAUTP should be in the range of 0.5-5.0 ps, with a smaller value providing tighter coupling to
the heat bath and, thus, faster heating and a less natural trajectory. Smaller values of TAUTP result in
smaller fluctuations in kinetic energy, but larger fluctuations in the total energy. Values much larger
than the length of the simulation result in a return to constant energy conditions.
ntc Flag for SHAKE to perform bond length constraints.[306] (See also NTF in the Potential function
section. In particular, typically NTF = NTC.) The SHAKE option should be used for most MD calculations.
The size of the MD timestep is determined by the fastest motions in the system. SHAKE
removes the bond stretching freedom, which is the fastest motion, and consequently allows a larger
timestep to be used. For water models, a special "three-point" algorithm is used.[307] Consequently, to
employ TIP3P set NTF = NTC = 2.
Since SHAKE is an algorithm based on dynamics, the minimizer is not aware of what SHAKE is
doing; for this reason, minimizations generally should be carried out without SHAKE. One exception is
short minimizations whose purpose is to remove bad contacts before dynamics can begin.
For parallel versions of sander only intramolecular atoms can be constrained. Thus, such atoms must be
in the same chain of the originating PDB file.
= 1 SHAKE is not performed (default)
= 2 bonds involving hydrogen are constrained
= 3 all bonds are constrained (not available for parallel or qmmm runs in sander)
calor2.in
Stage 1 Calentamiento de laz2 50K to 100K
&cntrl
imin=0, irest=1, ntx=5,
nstlim=10000, dt=0.0005,
ntc=2, ntf=2,
ntt=1, tautp=1.0,
tempi=50.0, temp0=100.0,
ntpr=50, ntwx=50, ntxo=1, ioutfm=0,
ntb=0, igb=5,
cut=16., rgbmax=16.
/
……
Una vez escritos los siete ficheros para el calentamiento, preparamos un fichero para lanzarlo
Calentar
…..
calor4.out: Etot = -238.6200 EKtot = 69.3072 EPtot = -307.9273
…….
calor6.out: Etot = -163.8971 EKtot = 112.2405 EPtot = -276.1375
…..
Con el commando
obtendriamos en un fichero
……
EKtot = 115.9015
EKtot = 103.4956
EKtot = 104.0817
EKtot = 113.9150
EKtot = 103.3006
EKtot = 99.6208
……
Ejercicio 4
Le añadimos al Sistema agua
Lo vamos a realizar sobre la molécula sin plegar y luego la optimizada con pm3
Si quisiéramos utilizar cualquier otra estructura para este ejercicio lo que haríamos es pasar el fichero a
pdb con el comando
%tleap
>source leaprc.protein.ff14SB
>source leaprc.water.tip3p
The solvateBox command creates a periodic solvent rectangular box around the solute UNIT.
The shape for solvateOct is a truncated octahedron. The solute UNIT is modified by the addition
of solvent RESIDUEs, such that the closest distance between any atom of the solute and the
edge of the periodic box is given by the distance parameter. The solvent box will be repeated
in all three spatial directions.
The optional closeness parameter can be used to control how close, in angstroms, solvent
ATOMs can come to solute ATOMs. The default value of the closeness argument is 1.0.
Smaller values allow solvent ATOMs to come closer to solute ATOMs. The criterion for
rejection of overlapping solvent RESIDUEs is if the distance between any solvent ATOM to
the closest solute ATOM is less than the sum of the ATOMs VANDERWAAL’s distances
multiplied by the closeness argument.
> mol = loadpdb my.pdb
> solvateOct mol TIP3PBOX 12.0 0.75
The solvateShell command adds a solvent shell to the solute UNIT. The resulting
solute/solvent UNIT will be irregular in shape since it will reflect the contours of the solute.
The solute UNIT is modified by the addition of solvent RESIDUEs. The solvent box will be
repeated in three directions to create a large solvent box that can contain the entire solute and a
shell thickness angstroms thick. The solvent RESIDUEs are then added to the solute UNIT if
they lie within the shell defined by thickness and do not overlap with the solute ATOMs. The
optional closeness parameter can be used to control how close solvent ATOMs can come to
solute ATOMs. The default value of the closeness argument is 1.0. Please see the solvateBox
command for more details on the closeness parameter.
> mol = loadpdb my.pdb
> solvateShell mol WATBOX216 12.0 0.8
>laz=loadpdb "lazop3_1.pdb"
Loading PDB file: ./lazop3_1.pdb
total atoms in file: 133
Checking Unit.
WARNING: The unperturbed charge of the unit: -0.999989 is not zero.
Building topology.
Building atom parameters.
Building bond parameters.
Building angle parameters.
Building proper torsion parameters.
Building improper torsion parameters.
total 39 improper torsions applied
Building H-Bond parameters.
Incorporating Non-Bonded adjustments.
Not Marking per-residue atom chain types.
Marking per-residue atom chain types.
(Residues lacking connect0/connect1 -
these don't have chain types marked:
CALA 1
NGLN 1
WAT 2548
)
(no restraints)
Calentar_agua
y comparamos
para extraer del fichero los datos podemos utilizar la siguiente orden:
Se van a utilizar los programas Autodock vina, MGLTools y amber para realizar el
docking entre seroalbumina y palmitato.
>source leaprc.lipid17
>li=PA
>savepdb li palmitoil.pdb
>quit
Una vez fuera del tleap, le añadimos los hidrógenos al palmitoil.pdb
Usamos el comando reduce de amber
%reduce palmitoil.pdb >palmitoil_h.pdb
% vim conf1
receptor= albu_h1.pdbqt
ligand= palmitoil_h1.pdbqt
center_x= 25
center_y= 8.4
center_z= 23.3
exhaustiveness= 8
salir
#################################################################
# If you used AutoDock Vina in your work, please cite: #
# #
# O. Trott, A. J. Olson, #
# AutoDock Vina: improving the speed and accuracy of docking #
# with a new scoring function, efficient optimization and #
# multithreading, Journal of Computational Chemistry 31 (2010) #
# 455-461 #
# #
# DOI 10.1002/jcc.21334 #
# #
# Please see http://vina.scripps.edu for more information. #
#################################################################
WARNING: The search space volume > 27000 Angstrom^3 (See FAQ)
Detected 2 CPUs
Reading input ... done.
Setting up the scoring function ... done.
Analyzing the binding site ... done.
Using random seed: 1380633772
Performing search ... done.
Posteriormente analizamos los resultados con la aplicación autodock de mgltools