5/13/2012 by Adam
authorAdam Liwo <adam@matrix.chem.cornell.edu>
Sun, 13 May 2012 06:16:52 +0000 (02:16 -0400)
committerAdam Liwo <adam@matrix.chem.cornell.edu>
Sun, 13 May 2012 06:16:52 +0000 (02:16 -0400)
1. Added options to run simulations with NMR-type distance restraints;
introduced array dhpb1 to store right borders of distance restraints
(left borders stored in dhpb, if dhpb1(i).eq.0 ith restraint is harmonic type,
> 0, quartic (NMR-like) type).

2. Added option to imposed either Calpha or SC (Cbeta) restraints; the pertinent
array is ibecacarb.

3. The above changes have been introduced in readrtns.F and energy_p_new_barrier.F
Cleaned excessive output in MREMD.F (energies at exchange)

4. prng.f replaces prng_32.F in Intel Makefiles; program hangs up with prng_32

87 files changed:
bin/unres/MD/unres_ifort_MPICH_E0LL2Y.exe
bin/unres/MD/unres_ifort_MPICH_GAB.exe
source/unres/src_MD/COMMON.SBRIDGE
source/unres/src_MD/MD_A-MTS.F
source/unres/src_MD/MD_A-MTS.o [new file with mode: 0644]
source/unres/src_MD/MP.o [new file with mode: 0644]
source/unres/src_MD/MREMD.F
source/unres/src_MD/MREMD.o [new file with mode: 0644]
source/unres/src_MD/Makefile_MPICH_ifort
source/unres/src_MD/add.o [new file with mode: 0644]
source/unres/src_MD/arcos.o [new file with mode: 0644]
source/unres/src_MD/banach.o [new file with mode: 0644]
source/unres/src_MD/blas.o [new file with mode: 0644]
source/unres/src_MD/bond_move.o [new file with mode: 0644]
source/unres/src_MD/cartder.o [new file with mode: 0644]
source/unres/src_MD/cartprint.o [new file with mode: 0644]
source/unres/src_MD/chainbuild.o [new file with mode: 0644]
source/unres/src_MD/check_bond.o [new file with mode: 0644]
source/unres/src_MD/check_sc_distr.o [new file with mode: 0644]
source/unres/src_MD/checkder_p.o [new file with mode: 0644]
source/unres/src_MD/cinfo.f
source/unres/src_MD/cinfo.o [new file with mode: 0644]
source/unres/src_MD/compare_s1.o [new file with mode: 0644]
source/unres/src_MD/compinfo [new file with mode: 0755]
source/unres/src_MD/contact.o [new file with mode: 0644]
source/unres/src_MD/convert.o [new file with mode: 0644]
source/unres/src_MD/cored.o [new file with mode: 0644]
source/unres/src_MD/dihed_cons.o [new file with mode: 0644]
source/unres/src_MD/djacob.o [new file with mode: 0644]
source/unres/src_MD/econstr_local.o [new file with mode: 0644]
source/unres/src_MD/eigen.o [new file with mode: 0644]
source/unres/src_MD/elecont.o [new file with mode: 0644]
source/unres/src_MD/energy_p_new-sep_barrier.o [new file with mode: 0644]
source/unres/src_MD/energy_p_new_barrier.F
source/unres/src_MD/energy_p_new_barrier.o [new file with mode: 0644]
source/unres/src_MD/energy_split-sep.o [new file with mode: 0644]
source/unres/src_MD/entmcm.o [new file with mode: 0644]
source/unres/src_MD/fitsq.o [new file with mode: 0644]
source/unres/src_MD/gauss.o [new file with mode: 0644]
source/unres/src_MD/gen_rand_conf.o [new file with mode: 0644]
source/unres/src_MD/geomout.o [new file with mode: 0644]
source/unres/src_MD/gnmr1.o [new file with mode: 0644]
source/unres/src_MD/gradient_p.o [new file with mode: 0644]
source/unres/src_MD/initialize_p.o [new file with mode: 0644]
source/unres/src_MD/int_to_cart.o [new file with mode: 0644]
source/unres/src_MD/intcartderiv.o [new file with mode: 0644]
source/unres/src_MD/intcor.o [new file with mode: 0644]
source/unres/src_MD/intlocal.o [new file with mode: 0644]
source/unres/src_MD/kinetic_lesyng.o [new file with mode: 0644]
source/unres/src_MD/lagrangian_lesyng.o [new file with mode: 0644]
source/unres/src_MD/local_move.o [new file with mode: 0644]
source/unres/src_MD/map.o [new file with mode: 0644]
source/unres/src_MD/matmult.o [new file with mode: 0644]
source/unres/src_MD/mc.o [new file with mode: 0644]
source/unres/src_MD/mcm.o [new file with mode: 0644]
source/unres/src_MD/minim_mcmf.o [new file with mode: 0644]
source/unres/src_MD/minimize_p.o [new file with mode: 0644]
source/unres/src_MD/misc.o [new file with mode: 0644]
source/unres/src_MD/moments.o [new file with mode: 0644]
source/unres/src_MD/muca_md.o [new file with mode: 0644]
source/unres/src_MD/parmread.o [new file with mode: 0644]
source/unres/src_MD/pinorm.o [new file with mode: 0644]
source/unres/src_MD/printmat.o [new file with mode: 0644]
source/unres/src_MD/prng.o [new file with mode: 0644]
source/unres/src_MD/q_measure.o [new file with mode: 0644]
source/unres/src_MD/randgens.o [new file with mode: 0644]
source/unres/src_MD/rattle.o [new file with mode: 0644]
source/unres/src_MD/readpdb.o [new file with mode: 0644]
source/unres/src_MD/readrtns.F
source/unres/src_MD/readrtns.o [new file with mode: 0644]
source/unres/src_MD/refsys.o [new file with mode: 0644]
source/unres/src_MD/regularize.o [new file with mode: 0644]
source/unres/src_MD/rescode.o [new file with mode: 0644]
source/unres/src_MD/rmdd.o [new file with mode: 0644]
source/unres/src_MD/rmsd.o [new file with mode: 0644]
source/unres/src_MD/sc_move.o [new file with mode: 0644]
source/unres/src_MD/sort.o [new file with mode: 0644]
source/unres/src_MD/stochfric.o [new file with mode: 0644]
source/unres/src_MD/sumsld.o [new file with mode: 0644]
source/unres/src_MD/surfatom.o [new file with mode: 0644]
source/unres/src_MD/test.o [new file with mode: 0644]
source/unres/src_MD/thread.o [new file with mode: 0644]
source/unres/src_MD/timing.o [new file with mode: 0644]
source/unres/src_MD/unres.o [new file with mode: 0644]
source/unres/src_MD/xdrf/ftocstr.o [new file with mode: 0644]
source/unres/src_MD/xdrf/libxdrf.a [new file with mode: 0644]
source/unres/src_MD/xdrf/libxdrf.o [new file with mode: 0644]

index ba5a1a7..b5077e8 100755 (executable)
Binary files a/bin/unres/MD/unres_ifort_MPICH_E0LL2Y.exe and b/bin/unres/MD/unres_ifort_MPICH_E0LL2Y.exe differ
index f772e87..39b0d89 100755 (executable)
Binary files a/bin/unres/MD/unres_ifort_MPICH_GAB.exe and b/bin/unres/MD/unres_ifort_MPICH_GAB.exe differ
index 4cc80c8..d75482c 100644 (file)
@@ -2,10 +2,10 @@
       integer ns,nss,nfree,iss
       common /sbridge/ ebr,d0cm,akcm,akth,akct,v1ss,v2ss,v3ss,
      & ns,nss,nfree,iss(maxss)
-      double precision dhpb,forcon
+      double precision dhpb,dhpb1,forcon
       integer ihpb,jhpb,nhpb
-      common /links/ dhpb(maxdim),forcon(maxdim),ihpb(maxdim),
-     & jhpb(maxdim),nhpb
+      common /links/ dhpb(maxdim),dhpb1(maxdim),forcon(maxdim),
+     & ihpb(maxdim),jhpb(maxdim),ibecarb(maxdim),nhpb
       double precision weidis
       common /restraints/ weidis
       integer link_start,link_end
index 29e4fcb..acbffa9 100644 (file)
@@ -1806,6 +1806,7 @@ c      rest2name = prefix(:ilen(prefix))//'.rst'
          write (iout,'(i3,3f10.5,3x,3f10.5)') i,(d_t(j,i),j=1,3),
      &   (d_t(j,i+nres),j=1,3)
        enddo                    
+       call flush(iout)
 c  Zeroing the total angular momentum of the system
        write(iout,*) "Calling the zero-angular 
      & momentum subroutine"
@@ -1823,6 +1824,7 @@ c Removing the velocity of the center of mass
       if(me.eq.king.or..not.out1file)then
        write (iout,*) "vcm right after adjustment:"
        write (iout,*) (vcm(j),j=1,3) 
+       call flush(iout)
       endif
       if (.not.rest) then              
          call chainbuild
@@ -2078,6 +2080,7 @@ c          write (iout,*) "i",i," ii",ii," geigen",geigen(i),
 c     &      " d_t_work_new",d_t_work_new(ii)
         enddo
       enddo
+      call flush(iout)
 c diagnostics
 c      Ek1=0.0d0
 c      ii=0
@@ -2116,6 +2119,7 @@ c Transfer to the d_t vector
 c      do i=0,nres-1
 c        write (iout,*) "d_t",i,(d_t(j,i),j=1,3)
 c      enddo
+c      call flush(iout)
       do i=nnt,nct
         if (itype(i).ne.10) then
           do j=1,3
diff --git a/source/unres/src_MD/MD_A-MTS.o b/source/unres/src_MD/MD_A-MTS.o
new file mode 100644 (file)
index 0000000..540b734
Binary files /dev/null and b/source/unres/src_MD/MD_A-MTS.o differ
diff --git a/source/unres/src_MD/MP.o b/source/unres/src_MD/MP.o
new file mode 100644 (file)
index 0000000..866b109
Binary files /dev/null and b/source/unres/src_MD/MP.o differ
index 9ddb9e9..576e43d 100644 (file)
@@ -782,6 +782,7 @@ ctime            call flush(iout)
                remd_t_bath(i)=remd_ene(n_ene+1,i)
                iremd_iset(i)=remd_ene(n_ene+2,i)
             enddo
+#ifdef DEBUG
             if(lmuca) then
 co             write(iout,*) 'REMD exchange temp,ene,elow,ehigh'
              do i=1,nodes
@@ -795,20 +796,27 @@ co             write(iout,*) 'REMD exchange temp,ene,elow,ehigh'
                 write(iout,'(6f12.5)') (remd_ene(j,i),j=1,n_ene)
               enddo
             endif
+#endif
 c-------------------------------------           
            IF(.not.usampl.and.hremd.eq.0) THEN
+#ifdef DEBUG
             write (iout,*) "Enter exchnge, remd_m",remd_m(1),
      &        " nodes",nodes
 ctime            call flush(iout)
             write (iout,*) "remd_m(1)",remd_m(1)
+#endif
             do irr=1,remd_m(1)
                i=ifirst(iran_num(1,remd_m(1)))
+#ifdef DEBUG
              write (iout,*) "i",i
+#endif
 ctime             call flush(iout)
 
              do ii=1,nodes-1
 
+#ifdef DEBUG
               write (iout,*) "i",i," nupa(0,i)",int(nupa(0,i))
+#endif
              if(i.gt.0.and.nupa(0,i).gt.0) then
               iex=i
 c              if (i.eq.1 .and. int(nupa(0,i)).eq.1) then
diff --git a/source/unres/src_MD/MREMD.o b/source/unres/src_MD/MREMD.o
new file mode 100644 (file)
index 0000000..0f920c5
Binary files /dev/null and b/source/unres/src_MD/MREMD.o differ
index e33762c..3ca0bb3 100644 (file)
@@ -44,7 +44,7 @@ object = unres.o arcos.o cartprint.o chainbuild.o convert.o initialize_p.o \
         cored.o rmdd.o geomout.o readpdb.o regularize.o thread.o fitsq.o mcm.o \
         mc.o bond_move.o refsys.o check_sc_distr.o check_bond.o contact.o djacob.o \
         eigen.o blas.o add.o entmcm.o minim_mcmf.o \
-        MP.o compare_s1.o prng_32.o \
+        MP.o compare_s1.o prng.o \
         banach.o rmsd.o elecont.o dihed_cons.o \
         sc_move.o local_move.o \
         intcartderiv.o lagrangian_lesyng.o\
diff --git a/source/unres/src_MD/add.o b/source/unres/src_MD/add.o
new file mode 100644 (file)
index 0000000..c13bb08
Binary files /dev/null and b/source/unres/src_MD/add.o differ
diff --git a/source/unres/src_MD/arcos.o b/source/unres/src_MD/arcos.o
new file mode 100644 (file)
index 0000000..8a850c9
Binary files /dev/null and b/source/unres/src_MD/arcos.o differ
diff --git a/source/unres/src_MD/banach.o b/source/unres/src_MD/banach.o
new file mode 100644 (file)
index 0000000..be285dd
Binary files /dev/null and b/source/unres/src_MD/banach.o differ
diff --git a/source/unres/src_MD/blas.o b/source/unres/src_MD/blas.o
new file mode 100644 (file)
index 0000000..9f988e0
Binary files /dev/null and b/source/unres/src_MD/blas.o differ
diff --git a/source/unres/src_MD/bond_move.o b/source/unres/src_MD/bond_move.o
new file mode 100644 (file)
index 0000000..945d517
Binary files /dev/null and b/source/unres/src_MD/bond_move.o differ
diff --git a/source/unres/src_MD/cartder.o b/source/unres/src_MD/cartder.o
new file mode 100644 (file)
index 0000000..64bd60c
Binary files /dev/null and b/source/unres/src_MD/cartder.o differ
diff --git a/source/unres/src_MD/cartprint.o b/source/unres/src_MD/cartprint.o
new file mode 100644 (file)
index 0000000..855db88
Binary files /dev/null and b/source/unres/src_MD/cartprint.o differ
diff --git a/source/unres/src_MD/chainbuild.o b/source/unres/src_MD/chainbuild.o
new file mode 100644 (file)
index 0000000..fbe8055
Binary files /dev/null and b/source/unres/src_MD/chainbuild.o differ
diff --git a/source/unres/src_MD/check_bond.o b/source/unres/src_MD/check_bond.o
new file mode 100644 (file)
index 0000000..2c09d2b
Binary files /dev/null and b/source/unres/src_MD/check_bond.o differ
diff --git a/source/unres/src_MD/check_sc_distr.o b/source/unres/src_MD/check_sc_distr.o
new file mode 100644 (file)
index 0000000..c6b399b
Binary files /dev/null and b/source/unres/src_MD/check_sc_distr.o differ
diff --git a/source/unres/src_MD/checkder_p.o b/source/unres/src_MD/checkder_p.o
new file mode 100644 (file)
index 0000000..9eaf7f0
Binary files /dev/null and b/source/unres/src_MD/checkder_p.o differ
index d3e68f7..63ead23 100644 (file)
@@ -1,10 +1,10 @@
 C DO NOT EDIT THIS FILE - IT HAS BEEN GENERATED BY COMPINFO.C
-C 2 5 38
+C 2 5 54
       subroutine cinfo
       include 'COMMON.IOUNITS'
       write(iout,*)'++++ Compile info ++++'
-      write(iout,*)'Version 2.5 build 38'
-      write(iout,*)'compiled Mon Apr  2 08:28:34 2012'
+      write(iout,*)'Version 2.5 build 54'
+      write(iout,*)'compiled Sun May 13 01:59:53 2012'
       write(iout,*)'compiled by adam@matrix.chem.cornell.edu'
       write(iout,*)'OS name:    Linux '
       write(iout,*)'OS release: 2.6.34.9-69.fc13.x86_64 '
diff --git a/source/unres/src_MD/cinfo.o b/source/unres/src_MD/cinfo.o
new file mode 100644 (file)
index 0000000..fe53af4
Binary files /dev/null and b/source/unres/src_MD/cinfo.o differ
diff --git a/source/unres/src_MD/compare_s1.o b/source/unres/src_MD/compare_s1.o
new file mode 100644 (file)
index 0000000..8025089
Binary files /dev/null and b/source/unres/src_MD/compare_s1.o differ
diff --git a/source/unres/src_MD/compinfo b/source/unres/src_MD/compinfo
new file mode 100755 (executable)
index 0000000..06263ff
Binary files /dev/null and b/source/unres/src_MD/compinfo differ
diff --git a/source/unres/src_MD/contact.o b/source/unres/src_MD/contact.o
new file mode 100644 (file)
index 0000000..503f772
Binary files /dev/null and b/source/unres/src_MD/contact.o differ
diff --git a/source/unres/src_MD/convert.o b/source/unres/src_MD/convert.o
new file mode 100644 (file)
index 0000000..7ad943e
Binary files /dev/null and b/source/unres/src_MD/convert.o differ
diff --git a/source/unres/src_MD/cored.o b/source/unres/src_MD/cored.o
new file mode 100644 (file)
index 0000000..9b880d0
Binary files /dev/null and b/source/unres/src_MD/cored.o differ
diff --git a/source/unres/src_MD/dihed_cons.o b/source/unres/src_MD/dihed_cons.o
new file mode 100644 (file)
index 0000000..b49de80
Binary files /dev/null and b/source/unres/src_MD/dihed_cons.o differ
diff --git a/source/unres/src_MD/djacob.o b/source/unres/src_MD/djacob.o
new file mode 100644 (file)
index 0000000..06351ba
Binary files /dev/null and b/source/unres/src_MD/djacob.o differ
diff --git a/source/unres/src_MD/econstr_local.o b/source/unres/src_MD/econstr_local.o
new file mode 100644 (file)
index 0000000..7afec0f
Binary files /dev/null and b/source/unres/src_MD/econstr_local.o differ
diff --git a/source/unres/src_MD/eigen.o b/source/unres/src_MD/eigen.o
new file mode 100644 (file)
index 0000000..7f0b6a0
Binary files /dev/null and b/source/unres/src_MD/eigen.o differ
diff --git a/source/unres/src_MD/elecont.o b/source/unres/src_MD/elecont.o
new file mode 100644 (file)
index 0000000..ba5f169
Binary files /dev/null and b/source/unres/src_MD/elecont.o differ
diff --git a/source/unres/src_MD/energy_p_new-sep_barrier.o b/source/unres/src_MD/energy_p_new-sep_barrier.o
new file mode 100644 (file)
index 0000000..85a496d
Binary files /dev/null and b/source/unres/src_MD/energy_p_new-sep_barrier.o differ
index e3f2c36..e3c154e 100644 (file)
@@ -4239,49 +4239,90 @@ C iii and jjj point to the residues for which the distance is assigned.
           iii=ii
           jjj=jj
         endif
-cd        write (iout,*) "i",i," ii",ii," iii",iii," jj",jj," jjj",jjj
+c        write (iout,*) "i",i," ii",ii," iii",iii," jj",jj," jjj",jjj,
+c     &    dhpb(i),dhpb1(i),forcon(i)
 C 24/11/03 AL: SS bridges handled separately because of introducing a specific
 C    distance and angle dependent SS bond potential.
         if (ii.gt.nres .and. itype(iii).eq.1 .and. itype(jjj).eq.1) then
           call ssbond_ene(iii,jjj,eij)
           ehpb=ehpb+2*eij
 cd          write (iout,*) "eij",eij
+        else if (ii.gt.nres .and. jj.gt.nres) then
+c Restraints from contact prediction
+          dd=dist(ii,jj)
+          if (dhpb1(i).gt.0.0d0) then
+            ehpb=ehpb+2*forcon(i)*gnmr1(dd,dhpb(i),dhpb1(i))
+            fac=forcon(i)*gnmr1prim(dd,dhpb(i),dhpb1(i))/dd
+c            write (iout,*) "beta nmr",
+c     &        dd,2*forcon(i)*gnmr1(dd,dhpb(i),dhpb1(i))
+          else
+            dd=dist(ii,jj)
+            rdis=dd-dhpb(i)
+C Get the force constant corresponding to this distance.
+            waga=forcon(i)
+C Calculate the contribution to energy.
+            ehpb=ehpb+waga*rdis*rdis
+c            write (iout,*) "beta reg",dd,waga*rdis*rdis
+C
+C Evaluate gradient.
+C
+            fac=waga*rdis/dd
+          endif  
+          do j=1,3
+            ggg(j)=fac*(c(j,jj)-c(j,ii))
+          enddo
+          do j=1,3
+            ghpbx(j,iii)=ghpbx(j,iii)-ggg(j)
+            ghpbx(j,jjj)=ghpbx(j,jjj)+ggg(j)
+          enddo
+          do k=1,3
+            ghpbc(k,jjj)=ghpbc(k,jjj)+ggg(k)
+            ghpbc(k,iii)=ghpbc(k,iii)-ggg(k)
+          enddo
         else
 C Calculate the distance between the two points and its difference from the
 C target distance.
-        dd=dist(ii,jj)
-        rdis=dd-dhpb(i)
+          dd=dist(ii,jj)
+          if (dhpb1(i).gt.0.0d0) then
+            ehpb=ehpb+2*forcon(i)*gnmr1(dd,dhpb(i),dhpb1(i))
+            fac=forcon(i)*gnmr1prim(dd,dhpb(i),dhpb1(i))/dd
+c            write (iout,*) "alph nmr",
+c     &        dd,2*forcon(i)*gnmr1(dd,dhpb(i),dhpb1(i))
+          else
+            rdis=dd-dhpb(i)
 C Get the force constant corresponding to this distance.
-        waga=forcon(i)
+            waga=forcon(i)
 C Calculate the contribution to energy.
-        ehpb=ehpb+waga*rdis*rdis
+            ehpb=ehpb+waga*rdis*rdis
+c            write (iout,*) "alpha reg",dd,waga*rdis*rdis
 C
 C Evaluate gradient.
 C
-        fac=waga*rdis/dd
+            fac=waga*rdis/dd
+          endif
 cd      print *,'i=',i,' ii=',ii,' jj=',jj,' dhpb=',dhpb(i),' dd=',dd,
 cd   &   ' waga=',waga,' fac=',fac
-        do j=1,3
-          ggg(j)=fac*(c(j,jj)-c(j,ii))
-        enddo
+            do j=1,3
+              ggg(j)=fac*(c(j,jj)-c(j,ii))
+            enddo
 cd      print '(i3,3(1pe14.5))',i,(ggg(j),j=1,3)
 C If this is a SC-SC distance, we need to calculate the contributions to the
 C Cartesian gradient in the SC vectors (ghpbx).
-        if (iii.lt.ii) then
+          if (iii.lt.ii) then
           do j=1,3
             ghpbx(j,iii)=ghpbx(j,iii)-ggg(j)
             ghpbx(j,jjj)=ghpbx(j,jjj)+ggg(j)
           enddo
-        endif
+          endif
 cgrad        do j=iii,jjj-1
 cgrad          do k=1,3
 cgrad            ghpbc(k,j)=ghpbc(k,j)+ggg(k)
 cgrad          enddo
 cgrad        enddo
-        do k=1,3
-          ghpbc(k,jjj)=ghpbc(k,jjj)+ggg(k)
-          ghpbc(k,iii)=ghpbc(k,iii)-ggg(k)
-        enddo
+          do k=1,3
+            ghpbc(k,jjj)=ghpbc(k,jjj)+ggg(k)
+            ghpbc(k,iii)=ghpbc(k,iii)-ggg(k)
+          enddo
         endif
       enddo
       ehpb=0.5D0*ehpb
diff --git a/source/unres/src_MD/energy_p_new_barrier.o b/source/unres/src_MD/energy_p_new_barrier.o
new file mode 100644 (file)
index 0000000..1c7d691
Binary files /dev/null and b/source/unres/src_MD/energy_p_new_barrier.o differ
diff --git a/source/unres/src_MD/energy_split-sep.o b/source/unres/src_MD/energy_split-sep.o
new file mode 100644 (file)
index 0000000..ff69df1
Binary files /dev/null and b/source/unres/src_MD/energy_split-sep.o differ
diff --git a/source/unres/src_MD/entmcm.o b/source/unres/src_MD/entmcm.o
new file mode 100644 (file)
index 0000000..41bfc41
Binary files /dev/null and b/source/unres/src_MD/entmcm.o differ
diff --git a/source/unres/src_MD/fitsq.o b/source/unres/src_MD/fitsq.o
new file mode 100644 (file)
index 0000000..7fc8f9c
Binary files /dev/null and b/source/unres/src_MD/fitsq.o differ
diff --git a/source/unres/src_MD/gauss.o b/source/unres/src_MD/gauss.o
new file mode 100644 (file)
index 0000000..f5236bb
Binary files /dev/null and b/source/unres/src_MD/gauss.o differ
diff --git a/source/unres/src_MD/gen_rand_conf.o b/source/unres/src_MD/gen_rand_conf.o
new file mode 100644 (file)
index 0000000..b051821
Binary files /dev/null and b/source/unres/src_MD/gen_rand_conf.o differ
diff --git a/source/unres/src_MD/geomout.o b/source/unres/src_MD/geomout.o
new file mode 100644 (file)
index 0000000..d03ca55
Binary files /dev/null and b/source/unres/src_MD/geomout.o differ
diff --git a/source/unres/src_MD/gnmr1.o b/source/unres/src_MD/gnmr1.o
new file mode 100644 (file)
index 0000000..e112fd1
Binary files /dev/null and b/source/unres/src_MD/gnmr1.o differ
diff --git a/source/unres/src_MD/gradient_p.o b/source/unres/src_MD/gradient_p.o
new file mode 100644 (file)
index 0000000..8bf549c
Binary files /dev/null and b/source/unres/src_MD/gradient_p.o differ
diff --git a/source/unres/src_MD/initialize_p.o b/source/unres/src_MD/initialize_p.o
new file mode 100644 (file)
index 0000000..1cbc858
Binary files /dev/null and b/source/unres/src_MD/initialize_p.o differ
diff --git a/source/unres/src_MD/int_to_cart.o b/source/unres/src_MD/int_to_cart.o
new file mode 100644 (file)
index 0000000..6c26e3b
Binary files /dev/null and b/source/unres/src_MD/int_to_cart.o differ
diff --git a/source/unres/src_MD/intcartderiv.o b/source/unres/src_MD/intcartderiv.o
new file mode 100644 (file)
index 0000000..f92db4b
Binary files /dev/null and b/source/unres/src_MD/intcartderiv.o differ
diff --git a/source/unres/src_MD/intcor.o b/source/unres/src_MD/intcor.o
new file mode 100644 (file)
index 0000000..ce5bd46
Binary files /dev/null and b/source/unres/src_MD/intcor.o differ
diff --git a/source/unres/src_MD/intlocal.o b/source/unres/src_MD/intlocal.o
new file mode 100644 (file)
index 0000000..f40c3ac
Binary files /dev/null and b/source/unres/src_MD/intlocal.o differ
diff --git a/source/unres/src_MD/kinetic_lesyng.o b/source/unres/src_MD/kinetic_lesyng.o
new file mode 100644 (file)
index 0000000..7964f24
Binary files /dev/null and b/source/unres/src_MD/kinetic_lesyng.o differ
diff --git a/source/unres/src_MD/lagrangian_lesyng.o b/source/unres/src_MD/lagrangian_lesyng.o
new file mode 100644 (file)
index 0000000..afcf45f
Binary files /dev/null and b/source/unres/src_MD/lagrangian_lesyng.o differ
diff --git a/source/unres/src_MD/local_move.o b/source/unres/src_MD/local_move.o
new file mode 100644 (file)
index 0000000..e3ef43b
Binary files /dev/null and b/source/unres/src_MD/local_move.o differ
diff --git a/source/unres/src_MD/map.o b/source/unres/src_MD/map.o
new file mode 100644 (file)
index 0000000..3fe2754
Binary files /dev/null and b/source/unres/src_MD/map.o differ
diff --git a/source/unres/src_MD/matmult.o b/source/unres/src_MD/matmult.o
new file mode 100644 (file)
index 0000000..5568df6
Binary files /dev/null and b/source/unres/src_MD/matmult.o differ
diff --git a/source/unres/src_MD/mc.o b/source/unres/src_MD/mc.o
new file mode 100644 (file)
index 0000000..a99a62e
Binary files /dev/null and b/source/unres/src_MD/mc.o differ
diff --git a/source/unres/src_MD/mcm.o b/source/unres/src_MD/mcm.o
new file mode 100644 (file)
index 0000000..1b0ee21
Binary files /dev/null and b/source/unres/src_MD/mcm.o differ
diff --git a/source/unres/src_MD/minim_mcmf.o b/source/unres/src_MD/minim_mcmf.o
new file mode 100644 (file)
index 0000000..a22757e
Binary files /dev/null and b/source/unres/src_MD/minim_mcmf.o differ
diff --git a/source/unres/src_MD/minimize_p.o b/source/unres/src_MD/minimize_p.o
new file mode 100644 (file)
index 0000000..bf93c13
Binary files /dev/null and b/source/unres/src_MD/minimize_p.o differ
diff --git a/source/unres/src_MD/misc.o b/source/unres/src_MD/misc.o
new file mode 100644 (file)
index 0000000..031e467
Binary files /dev/null and b/source/unres/src_MD/misc.o differ
diff --git a/source/unres/src_MD/moments.o b/source/unres/src_MD/moments.o
new file mode 100644 (file)
index 0000000..f271eee
Binary files /dev/null and b/source/unres/src_MD/moments.o differ
diff --git a/source/unres/src_MD/muca_md.o b/source/unres/src_MD/muca_md.o
new file mode 100644 (file)
index 0000000..87fc0e3
Binary files /dev/null and b/source/unres/src_MD/muca_md.o differ
diff --git a/source/unres/src_MD/parmread.o b/source/unres/src_MD/parmread.o
new file mode 100644 (file)
index 0000000..fea3369
Binary files /dev/null and b/source/unres/src_MD/parmread.o differ
diff --git a/source/unres/src_MD/pinorm.o b/source/unres/src_MD/pinorm.o
new file mode 100644 (file)
index 0000000..b9f7de8
Binary files /dev/null and b/source/unres/src_MD/pinorm.o differ
diff --git a/source/unres/src_MD/printmat.o b/source/unres/src_MD/printmat.o
new file mode 100644 (file)
index 0000000..81bb89a
Binary files /dev/null and b/source/unres/src_MD/printmat.o differ
diff --git a/source/unres/src_MD/prng.o b/source/unres/src_MD/prng.o
new file mode 100644 (file)
index 0000000..30e4e32
Binary files /dev/null and b/source/unres/src_MD/prng.o differ
diff --git a/source/unres/src_MD/q_measure.o b/source/unres/src_MD/q_measure.o
new file mode 100644 (file)
index 0000000..49812f8
Binary files /dev/null and b/source/unres/src_MD/q_measure.o differ
diff --git a/source/unres/src_MD/randgens.o b/source/unres/src_MD/randgens.o
new file mode 100644 (file)
index 0000000..a3196f8
Binary files /dev/null and b/source/unres/src_MD/randgens.o differ
diff --git a/source/unres/src_MD/rattle.o b/source/unres/src_MD/rattle.o
new file mode 100644 (file)
index 0000000..847aa7d
Binary files /dev/null and b/source/unres/src_MD/rattle.o differ
diff --git a/source/unres/src_MD/readpdb.o b/source/unres/src_MD/readpdb.o
new file mode 100644 (file)
index 0000000..1b7c606
Binary files /dev/null and b/source/unres/src_MD/readpdb.o differ
index 6ce9ec3..08d4125 100644 (file)
@@ -44,7 +44,8 @@ C Print restraint information
      &write (iout,'(a,i5,a)') "The following",nhpb-nss,
      & " distance constraints have been imposed"
       do i=nss+1,nhpb
-        write (iout,'(3i6,f10.5)') i-nss,ihpb(i),jhpb(i),forcon(i)
+        write (iout,'(3i6,i2,3f10.5)') i-nss,ihpb(i),jhpb(i),
+     &     ibecarb(i),dhpb(i),dhpb1(i),forcon(i)
       enddo
 #ifdef MPI
       endif
@@ -2475,21 +2476,29 @@ c        write (iout,*) i,ifrag_(1,i),ifrag_(2,i),wfrag_(i)
         endif
       enddo 
       do i=1,ndist_
-        read (inp,*) ihpb(nhpb+1),jhpb(nhpb+1),forcon(nhpb+1)
+        read (inp,*) ihpb(nhpb+1),jhpb(nhpb+1),dhpb(i),dhpb1(i),
+     &     ibecarb(i),forcon(nhpb+1)
         if (forcon(nhpb+1).gt.0.0d0) then
           nhpb=nhpb+1
-          dhpb(nhpb)=dist(ihpb(nhpb),jhpb(nhpb))
+          if (ibecarb(i).gt.0) then
+            ihpb(i)=ihpb(i)+nres
+            jhpb(i)=jhpb(i)+nres
+          endif
+          if (dhpb(nhpb).eq.0.0d0) 
+     &       dhpb(nhpb)=dist(ihpb(nhpb),jhpb(nhpb))
+        endif
+      enddo
 #ifdef MPI
-          if (.not.out1file .or. me.eq.king)
-     &    write (iout,'(a,3i5,f8.2,f10.1)') "+dist.constr ",
-     &     nhpb,ihpb(nhpb),jhpb(nhpb),dhpb(nhpb),forcon(nhpb)
-#else
-          write (iout,'(a,3i5,f8.2,f10.1)') "+dist.constr ",
-     &     nhpb,ihpb(nhpb),jhpb(nhpb),dhpb(nhpb),forcon(nhpb)
+      if (.not.out1file .or. me.eq.king) then
 #endif
-        endif
+      do i=1,nhbp
+          write (iout,'(a,3i5,2f8.2,i2,f10.1)') "+dist.constr ",
+     &     i,ihpb(i),jhpb(i),dhpb(i),dhpb1(i),ibecarb(i),forcon(i)
       enddo
       call flush(iout)
+#ifdef MPI
+      endif
+#endif
       return
       end
 c-------------------------------------------------------------------------------
diff --git a/source/unres/src_MD/readrtns.o b/source/unres/src_MD/readrtns.o
new file mode 100644 (file)
index 0000000..34f25e1
Binary files /dev/null and b/source/unres/src_MD/readrtns.o differ
diff --git a/source/unres/src_MD/refsys.o b/source/unres/src_MD/refsys.o
new file mode 100644 (file)
index 0000000..0c54900
Binary files /dev/null and b/source/unres/src_MD/refsys.o differ
diff --git a/source/unres/src_MD/regularize.o b/source/unres/src_MD/regularize.o
new file mode 100644 (file)
index 0000000..ae900f1
Binary files /dev/null and b/source/unres/src_MD/regularize.o differ
diff --git a/source/unres/src_MD/rescode.o b/source/unres/src_MD/rescode.o
new file mode 100644 (file)
index 0000000..d0aa37a
Binary files /dev/null and b/source/unres/src_MD/rescode.o differ
diff --git a/source/unres/src_MD/rmdd.o b/source/unres/src_MD/rmdd.o
new file mode 100644 (file)
index 0000000..9b3775d
Binary files /dev/null and b/source/unres/src_MD/rmdd.o differ
diff --git a/source/unres/src_MD/rmsd.o b/source/unres/src_MD/rmsd.o
new file mode 100644 (file)
index 0000000..080ee1f
Binary files /dev/null and b/source/unres/src_MD/rmsd.o differ
diff --git a/source/unres/src_MD/sc_move.o b/source/unres/src_MD/sc_move.o
new file mode 100644 (file)
index 0000000..815e622
Binary files /dev/null and b/source/unres/src_MD/sc_move.o differ
diff --git a/source/unres/src_MD/sort.o b/source/unres/src_MD/sort.o
new file mode 100644 (file)
index 0000000..eaab380
Binary files /dev/null and b/source/unres/src_MD/sort.o differ
diff --git a/source/unres/src_MD/stochfric.o b/source/unres/src_MD/stochfric.o
new file mode 100644 (file)
index 0000000..3b66ed2
Binary files /dev/null and b/source/unres/src_MD/stochfric.o differ
diff --git a/source/unres/src_MD/sumsld.o b/source/unres/src_MD/sumsld.o
new file mode 100644 (file)
index 0000000..5018208
Binary files /dev/null and b/source/unres/src_MD/sumsld.o differ
diff --git a/source/unres/src_MD/surfatom.o b/source/unres/src_MD/surfatom.o
new file mode 100644 (file)
index 0000000..f2eb57b
Binary files /dev/null and b/source/unres/src_MD/surfatom.o differ
diff --git a/source/unres/src_MD/test.o b/source/unres/src_MD/test.o
new file mode 100644 (file)
index 0000000..af1598e
Binary files /dev/null and b/source/unres/src_MD/test.o differ
diff --git a/source/unres/src_MD/thread.o b/source/unres/src_MD/thread.o
new file mode 100644 (file)
index 0000000..1d5234f
Binary files /dev/null and b/source/unres/src_MD/thread.o differ
diff --git a/source/unres/src_MD/timing.o b/source/unres/src_MD/timing.o
new file mode 100644 (file)
index 0000000..927f88a
Binary files /dev/null and b/source/unres/src_MD/timing.o differ
diff --git a/source/unres/src_MD/unres.o b/source/unres/src_MD/unres.o
new file mode 100644 (file)
index 0000000..06b79e5
Binary files /dev/null and b/source/unres/src_MD/unres.o differ
diff --git a/source/unres/src_MD/xdrf/ftocstr.o b/source/unres/src_MD/xdrf/ftocstr.o
new file mode 100644 (file)
index 0000000..f0102ea
Binary files /dev/null and b/source/unres/src_MD/xdrf/ftocstr.o differ
diff --git a/source/unres/src_MD/xdrf/libxdrf.a b/source/unres/src_MD/xdrf/libxdrf.a
new file mode 100644 (file)
index 0000000..9673526
Binary files /dev/null and b/source/unres/src_MD/xdrf/libxdrf.a differ
diff --git a/source/unres/src_MD/xdrf/libxdrf.o b/source/unres/src_MD/xdrf/libxdrf.o
new file mode 100644 (file)
index 0000000..1f81ca3
Binary files /dev/null and b/source/unres/src_MD/xdrf/libxdrf.o differ