diff --git a/.gitmodules b/.gitmodules index 30a29d29..0e699866 100644 --- a/.gitmodules +++ b/.gitmodules @@ -19,5 +19,5 @@ url = https://github.com/fortran-lang/test-drive.git [submodule "subprojects/tblite"] path = subprojects/tblite - url = https://github.com/tblite/tblite.git - branch = main + url = https://github.com/pprcht/tblite.git + branch = xtb_solvation diff --git a/CMakeLists.txt b/CMakeLists.txt index 69a7bb21..36e2e357 100644 --- a/CMakeLists.txt +++ b/CMakeLists.txt @@ -54,6 +54,16 @@ if(NOT TARGET "OpenMP::OpenMP_Fortran" AND WITH_OpenMP) find_package("OpenMP" REQUIRED) endif() +# Check if we are using OpenBLAS (need a precompiler definition if yes) +if(LAPACK_LIBRARIES) + string(FIND "${LAPACK_LIBRARIES}" "openblas" _openblas_in_lapack) + + if(NOT _openblas_in_lapack EQUAL -1) + message(STATUS "libopenblas was found as part of LAPACK") + add_compile_definitions(WITH_OPENBLAS) + endif() +endif() + # Fortran unit test interface (also used by other subprojects) if(NOT TARGET "test-drive::test-drive" AND WITH_TESTS) find_package("test-drive" REQUIRED) diff --git a/README.md b/README.md index 9750416b..7bf973ab 100644 --- a/README.md +++ b/README.md @@ -57,10 +57,8 @@ Working and tested builds of CREST (mostly on Ubuntu 20.04 LTS): | Build System | Compiler | Linear Algebra Backend | Build type | Status | Note | |--------------|----------|------------------------|:--------------:|:----------:|:----:| -| CMake 3.28.3 | GNU (gcc 10.3.0) | [OpenBLAS](https://github.com/xianyi/OpenBLAS) (with OpenMP) | dynamic | ✅ || -| CMake 3.28.3 | GNU (gcc 10.3.0) | [MKL shared (oneAPI 2023.1)](https://www.intel.com/content/www/us/en/developer/tools/oneapi/onemkl.html) | dynamic | ✅ || -| CMake 3.28.3 | GNU (gcc 9.5.0) | [MKL shared (oneAPI 2023.1)](https://www.intel.com/content/www/us/en/developer/tools/oneapi/onemkl.html) | dynamic | ✅ || -| CMake 3.28.3 | [Intel (`ifort`/`icc` 2021.9.0)](https://www.intel.com/content/www/us/en/developer/tools/oneapi/toolkits.html) | [MKL static (oneAPI 2023.1)](https://www.intel.com/content/www/us/en/developer/tools/oneapi/onemkl.html) | dynamic | ⚠️ | OpenMP problem ([#285](https://github.com/crest-lab/crest/issues/285)) | +| CMake 3.30.2 | GNU (gcc 14.1.0) | [libopenblas 0.3.27](https://anaconda.org/conda-forge/libopenblas) | dynamic | ✅ || +| CMake 3.28.3 | [Intel (`ifort`/`icc` 2021.9.0)](https://www.intel.com/content/www/us/en/developer/tools/oneapi/toolkits.html) | [MKL static (oneAPI 2023.1)](https://www.intel.com/content/www/us/en/developer/tools/oneapi/onemkl.html) | dynamic | ⚠️ | OpenMP/MKL problem ([#285](https://github.com/crest-lab/crest/issues/285)) | | Meson 1.2.0 | [Intel (`ifort`/`icc` 2021.9.0)](https://www.intel.com/content/www/us/en/developer/tools/oneapi/toolkits.html) | [MKL static (oneAPI 2023.1)](https://www.intel.com/content/www/us/en/developer/tools/oneapi/onemkl.html) | static | ✅ | [continuous release build](https://github.com/crest-lab/crest/releases/tag/latest) | | Meson 1.2.0 | [Intel (`ifort` 2021.9.0/`icx` 2023.1.0)](https://www.intel.com/content/www/us/en/developer/tools/oneapi/toolkits.html) | [MKL static (oneAPI 2023.1)](https://www.intel.com/content/www/us/en/developer/tools/oneapi/onemkl.html) | static | ✅ || diff --git a/src/CMakeLists.txt b/src/CMakeLists.txt index c86cbb46..49c591a2 100644 --- a/src/CMakeLists.txt +++ b/src/CMakeLists.txt @@ -37,6 +37,7 @@ list(APPEND srcs "${dir}/axis_module.f90" "${dir}/biasmerge.f90" "${dir}/bondconstraint.f90" + "${dir}/canonical.f90" "${dir}/ccegen.f90" "${dir}/choose_settings.f90" "${dir}/classes.f90" @@ -79,7 +80,6 @@ list(APPEND srcs "${dir}/strucreader.f90" "${dir}/symmetry2.f90" "${dir}/symmetry_i.c" - "${dir}/testmol.f90" "${dir}/timer.f90" "${dir}/trackorigin.f90" "${dir}/utilmod.f90" diff --git a/src/algos/parallel.f90 b/src/algos/parallel.f90 index 71afe979..b3926240 100644 --- a/src/algos/parallel.f90 +++ b/src/algos/parallel.f90 @@ -99,7 +99,6 @@ subroutine crest_sploop(env,nat,nall,at,xyz,eread) integer :: i,j,k,l,io,ich,ich2,c,z,job_id,zcopy logical :: pr,wr,ex type(calcdata),allocatable :: calculations(:) - integer :: T !> number of parallel running instances real(wp) :: energy,gnorm real(wp),allocatable :: grad(:,:),grads(:,:,:) integer :: thread_id,vz,job @@ -107,6 +106,8 @@ subroutine crest_sploop(env,nat,nall,at,xyz,eread) real(wp) :: percent,runtime type(timer) :: profiler + integer :: T,Tn !> threads and threads per core + logical :: nested !>--- check if we have any calculation settings allocated if (env%calc%ncalculations < 1) then @@ -114,6 +115,11 @@ subroutine crest_sploop(env,nat,nall,at,xyz,eread) return end if +!>--- prepare calculation objects for parallelization (one per thread) + call new_ompautoset(env,'auto_nested',nall,T,Tn) + nested = env%omp_allow_nested + + !>--- prepare objects for parallelization T = env%threads allocate (calculations(T),source=env%calc) @@ -153,7 +159,7 @@ subroutine crest_sploop(env,nat,nall,at,xyz,eread) !>--- loop over ensemble !$omp parallel & !$omp shared(env,calculations,nat,nall,at,xyz,eread,grads,c,k,z,pr,wr) & - !$omp shared(ich,ich2,mols) + !$omp shared(ich,ich2,mols, nested,Tn) !$omp single do i = 1,nall @@ -162,6 +168,9 @@ subroutine crest_sploop(env,nat,nall,at,xyz,eread) !$omp task firstprivate( vz ) private(i,j,job,energy,io,thread_id,zcopy) call initsignal() + !>--- OpenMP nested region threads + if (nested) call ompmklset(Tn) + thread_id = OMP_GET_THREAD_NUM() job = thread_id+1 !>--- modify calculation spaces @@ -259,7 +268,6 @@ subroutine crest_oloop(env,nat,nall,at,xyz,eread,dump,customcalc) integer :: i,j,k,l,io,ich,ich2,c,z,job_id,zcopy logical :: pr,wr,ex type(calcdata),allocatable :: calculations(:) - integer :: T !> number of parallel running instances real(wp) :: energy,gnorm real(wp),allocatable :: grads(:,:,:) integer :: thread_id,vz,job @@ -267,6 +275,8 @@ subroutine crest_oloop(env,nat,nall,at,xyz,eread,dump,customcalc) real(wp) :: percent,runtime type(calcdata),pointer :: mycalc type(timer) :: profiler + integer :: T,Tn !> threads and threads per core + logical :: nested !>--- decide wether to skip this call if (trackrestart(env)) then @@ -287,8 +297,11 @@ subroutine crest_oloop(env,nat,nall,at,xyz,eread,dump,customcalc) return end if +!>--- prepare calculation objects for parallelization (one per thread) + call new_ompautoset(env,'auto_nested',nall,T,Tn) + nested = env%omp_allow_nested + !>--- prepare objects for parallelization - T = env%threads allocate (calculations(T),source=mycalc) allocate (mols(T),molsnew(T)) do i = 1,T @@ -299,6 +312,9 @@ subroutine crest_oloop(env,nat,nall,at,xyz,eread,dump,customcalc) if (.not.ex) then io = makedir(trim(mycalc%calcs(j)%calcspace)) end if + if(calculations(i)%calcs(j)%id == jobtype%tblite)then + calculations(i)%optnewinit=.true. + endif write (atmp,'(a,"_",i0)') sep,i calculations(i)%calcs(j)%calcspace = mycalc%calcs(j)%calcspace//trim(atmp) call calculations(i)%calcs(j)%printid(i,j) @@ -331,7 +347,7 @@ subroutine crest_oloop(env,nat,nall,at,xyz,eread,dump,customcalc) !>--- loop over ensemble !$omp parallel & !$omp shared(env,calculations,nat,nall,at,xyz,eread,grads,c,k,z,pr,wr,dump) & - !$omp shared(ich,ich2,mols,molsnew) + !$omp shared(ich,ich2,mols,molsnew, nested,Tn) !$omp single do i = 1,nall @@ -340,6 +356,9 @@ subroutine crest_oloop(env,nat,nall,at,xyz,eread,dump,customcalc) !$omp task firstprivate( vz ) private(j,job,energy,io,atmp,gnorm,thread_id,zcopy) call initsignal() + !>--- OpenMP nested region threads + if (nested) call ompmklset(Tn) + thread_id = OMP_GET_THREAD_NUM() job = thread_id+1 !>--- modify calculation spaces @@ -1036,7 +1055,7 @@ subroutine parallel_md_finish_printout(MD,vz,io,profiler) if (io == 0) then write (btmp,'(a,1x,i3,a)') trim(atmp),vz,' completed successfully' else - write (btmp,'(a,1x,i3,a)') trim(atmp),vz,' terminated with early' + write (btmp,'(a,1x,i3,a)') trim(atmp),vz,' terminated EARLY' end if call profiler%write_timing(stdout,vz,trim(btmp)) diff --git a/src/algos/playground.f90 b/src/algos/playground.f90 index be0036dd..bffbf199 100644 --- a/src/algos/playground.f90 +++ b/src/algos/playground.f90 @@ -31,15 +31,7 @@ subroutine crest_playground(env,tim) use crest_data use crest_calculator use strucrd - use optimize_module - use tblite_api - use wiberg_mayer, only: write_wbo - use adjacency - use zdata - use probabilities_module - use parse_csv - use cregen_interface - use dynamics_module + use canonical_mod implicit none type(systemdata),intent(inout) :: env type(timer),intent(inout) :: tim @@ -55,21 +47,11 @@ subroutine crest_playground(env,tim) logical,allocatable :: rings(:,:) integer,allocatable :: tmp(:) logical :: connected,fail - type(zmolecule) :: zmol real(wp) :: energy real(wp),allocatable :: grad(:,:),geo(:,:),csv(:,:) - integer,allocatable :: na(:),nb(:),nc(:),at2(:) - integer :: nat2 - real(wp),allocatable :: mu(:) - real(wp) :: kappa,rrad - - integer :: nsim - character(len=:),allocatable :: ensnam - type(mddata) :: mddat - type(mddata),allocatable :: mddats(:) - + type(canonical_sorter) :: can !========================================================================================! call tim%start(14,'Test implementation') !========================================================================================! @@ -88,23 +70,20 @@ subroutine crest_playground(env,tim) write(*,*) !========================================================================================! -!>--- sets the MD length according to a flexibility measure - call md_length_setup(env) -!>--- create the MD calculator saved to env - call env_to_mddat(env) - - - nsim = 3 - call crest_search_multimd_init(env,mol,mddat,nsim) - allocate (mddats(nsim), source=mddat) - call crest_search_multimd_init2(env,mddats,nsim) + allocate(grad(3,mol%nat), source=0.0_wp) + call env2calc(env,calc,mol) + calc%calcs(1)%rdwbo=.true. + call calc%info(stdout) - call crest_search_multimd(env,mol,mddats,nsim) -!>--- a file called crest_dynamics.trj should have been written - ensnam = 'crest_dynamics.trj' -!>--- deallocate for next iteration - if(allocated(mddats))deallocate(mddats) + call engrad(mol,calc,energy,grad,io) + call calculation_summary(calc,mol,energy,grad) + + write(stdout,*) + write(stdout,*) 'CANGEN algorithm' + call can%init(mol,calc%calcs(1)%wbo,'apsp+') + call can%stereo(mol) + call can%rankprint(mol) !========================================================================================! call tim%stop(14) diff --git a/src/algos/protonate.f90 b/src/algos/protonate.f90 index 62c564c2..70da0163 100644 --- a/src/algos/protonate.f90 +++ b/src/algos/protonate.f90 @@ -38,6 +38,7 @@ subroutine crest_new_protonate(env,tim) use parallel_interface use cregen_interface use iomod + use utilities,only:binomial implicit none type(systemdata),intent(inout) :: env type(timer),intent(inout) :: tim @@ -60,6 +61,7 @@ subroutine crest_new_protonate(env,tim) real(wp),allocatable :: xyzp(:,:,:) real(wp),allocatable :: ep(:) logical,allocatable :: atlist(:) + character(len=*),parameter :: basename = 'protonate_' !========================================================================================! write (stdout,*) !call system('figlet singlepoint') @@ -75,7 +77,7 @@ subroutine crest_new_protonate(env,tim) write (stdout,*) 'Cite as:' write (stdout,*) ' P.Pracht, C.A.Bauer, S.Grimme' write (stdout,*) ' JCC, 2017, 38, 2618–2631.' - write (stdout,*) + write (stdout,*) !========================================================================================! call new_ompautoset(env,'max',0,T,Tn) @@ -139,7 +141,7 @@ subroutine crest_new_protonate(env,tim) case (3) write (stdout,'(1x,i5,1x,a,3F12.5)') i,'del.π',protxyz(1:3,i)*autoaa case default - write (stdout,'(1x,i5,1x,a,3F12.5)') i,'??? ',protxyz(1:3,i)*autoaa + write (stdout,'(1x,i5,1x,a,3F12.5)') i,'??? ',protxyz(1:3,i)*autoaa end select end do else @@ -157,9 +159,15 @@ subroutine crest_new_protonate(env,tim) pstep = 0 write (stdout,'(a)',advance='yes') '> Generating candidate structures ... ' flush (stdout) - natp = mol%nat+1 + if (env%protb%amount > np) then + env%protb%amount = np + write (stdout,'(a,i0,a)') '> A maximum of ',np,' protonation sites can be used' + end if + natp = mol%nat+env%protb%amount + npnew = binomial(np,env%protb%amount) + write (stdout,'(a,i0,a)') '> Up to ',npnew,' new structures' allocate (atp(natp),source=0) - allocate (xyzp(3,natp,np),ep(np),source=0.0_wp) + allocate (xyzp(3,natp,npnew),ep(npnew),source=0.0_wp) call protonation_candidates(env,mol,natp,np,protxyz,atp,xyzp,npnew) !>--- NOTE: after this the global charge (env%chrg) and all charges saved in the calc levels have been increased @@ -171,10 +179,10 @@ subroutine crest_new_protonate(env,tim) return end if - write (atmp,'(a,i0,a)') 'protonate_',pstep,'.xyz' + write (atmp,'(a,i0,a)') basename,pstep,'.xyz' write (stdout,'(a,a,a,i0,a)') '> Write ',trim(atmp),' with ',npnew,' candidates ... ' - call wrensemble('protonate_0.xyz',natp,npnew,atp,xyzp(:,:,1:npnew)*autoaa,ep(1:npnew)) + call wrensemble(basename//'0.xyz',natp,npnew,atp,xyzp(:,:,1:npnew)*autoaa,ep(1:npnew)) write (stdout,'(a)') '> done.' write (stdout,*) @@ -192,12 +200,12 @@ subroutine crest_new_protonate(env,tim) allocate (tmpcalc_ff) tmpcalc_ff%optnewinit = .true. env%calc%optnewinit = .true. - tmpcalc_ff%optnewinit=.true. + tmpcalc_ff%optnewinit = .true. call tmpset%create('gfnff') tmpset%chrg = env%chrg call tmpcalc_ff%add(tmpset) tmpcalc_ff%maxcycle = 10000 - call tmpcalc_ff%info(stdout) + call tmpcalc_ff%info(stdout) !>--- Run optimizations call tim%start(15,'Ensemble optimization (FF)') @@ -209,21 +217,22 @@ subroutine crest_new_protonate(env,tim) deallocate (tmpcalc_ff) pstep = pstep+1 - write (atmp,'(a,i0,a)') 'protonate_',pstep,'.xyz' + write (atmp,'(a,i0,a)') basename,pstep,'.xyz' write (stdout,'(a,a,a)') '> Write ',trim(atmp),' with optimized structures ... ' call wrensemble(trim(atmp),natp,npnew,atp,xyzp(:,:,1:npnew)*autoaa,ep(1:npnew)) + deallocate (xyzp,atp) !> clear this space to re-use it !>--- sorting write (stdout,'(a)') '> Sorting structures by energy to remove failed opts. ...' - env%ewin = 5000.0_wp + env%ewin = 1000.0_wp call newcregen(env,7,trim(atmp)) call rename(trim(atmp)//'.sorted',trim(atmp)) + write (stdout,'(a)') '> Sorted file was renamed to '//trim(atmp) write (stdout,'(a)') '> WARNING: These are force-field energies which are ' write (stdout,'(a)') ' NOT(!) accurate for bond formation and breaking!' write (stdout,*) !>--- re-read sorted ensemble - deallocate (xyzp,atp) !> clear this space to re-use it call rdensemble(trim(atmp),natp,npnew,atp,xyzp) xyzp = xyzp*aatoau !> don't forget to restore BOHR end if @@ -245,6 +254,7 @@ subroutine crest_new_protonate(env,tim) end if end do tmpcalc%nfreeze = count(atlist) + tmpcalc%optnewinit = .true. write (stdout,'(a,i0,a)') '> ',tmpcalc%nfreeze,' frozen atoms. All H non-frozen.' call move_alloc(atlist,tmpcalc%freezelist) call tmpcalc%info(stdout) @@ -256,34 +266,38 @@ subroutine crest_new_protonate(env,tim) call tim%stop(16) pstep = pstep+1 - write (atmp,'(a,i0,a)') 'protonate_',pstep,'.xyz' + write (atmp,'(a,i0,a)') basename,pstep,'.xyz' write (stdout,'(a,a,a)') '> Write ',trim(atmp),' with optimized structures ... ' call wrensemble(trim(atmp),natp,npnew,atp,xyzp(:,:,1:npnew)*autoaa,ep(1:npnew)) + deallocate (xyzp,atp) !> clear this space to re-use it + deallocate (tmpcalc) + +! call tim%start(17,'Ensemble refinement') +! call crest_refine(env,trim(atmp),trim(atmp)) +! call tim%stop(17) !>--- sorting write (stdout,'(a)') '> Sorting structures by energy to remove failed opts. ...' - env%ewin = env%protb%ewin*10.0_wp !> large energy threshold + env%ewin = env%protb%ewin*5.0_wp !> large energy threshold call newcregen(env,7,trim(atmp)) call rename(trim(atmp)//'.sorted',trim(atmp)) + write (stdout,'(a)') '> Sorted file was renamed to '//trim(atmp) write (stdout,*) !>--- re-read sorted ensemble - deallocate (xyzp,atp) !> clear this space to re-use it call rdensemble(trim(atmp),natp,npnew,atp,xyzp) xyzp = xyzp*aatoau !> don't forget to restore BOHR - deallocate (tmpcalc) end if !========================================================================================! !>--- Optimize with global settings if (env%protb%finalopt.and.env%protb%ffopt) then call smallhead('Final Protomer Ensemble Optimization') - allocate(tmpcalc) + allocate (tmpcalc) call env2calc(env,tmpcalc,mol) call tmpcalc%info(stdout) - !tmpcalc%maxcycle=5 - !tmpcalc%anopt=.true. + tmpcalc%optnewinit = .true. call tim%start(20,'Ensemble optimization') call print_opt_data(env%calc,stdout) write (stdout,'(a,i0,a)') '> ',npnew,' structures to optimize ...' @@ -291,19 +305,35 @@ subroutine crest_new_protonate(env,tim) call tim%stop(20) pstep = pstep+1 - write (atmp,'(a,i0,a)') 'protonate_',pstep,'.xyz' + write (atmp,'(a,i0,a)') basename,pstep,'.xyz' write (stdout,'(a,a,a)') '> Write ',trim(atmp),' with optimized structures ... ' call wrensemble(trim(atmp),natp,npnew,atp,xyzp(:,:,1:npnew)*autoaa,ep(1:npnew)) + deallocate (xyzp,atp) + + call tim%start(17,'Ensemble refinement') + call crest_refine(env,trim(atmp),trim(atmp)) + call tim%stop(17) !>--- sorting write (stdout,'(a)') '> Sorting structures by energy ...' - env%ewin = env%protb%ewin + env%ewin = env%protb%ewin*3.0_wp call newcregen(env,7,trim(atmp)) - call rename(trim(atmp)//'.sorted','protonated.xyz') - else - call rename(trim(atmp),'protonated.xyz') + call rename(trim(atmp)//'.sorted',trim(atmp)) + end if + +!========================================================================================! +!> Remove doubly generated tautomers + call protonation_prep_canonical(env,mol,trim(atmp)) + +!========================================================================================! +!>--- move final ensemble to protonated.xyz + call rename(trim(atmp),'protonated.xyz') + write (stdout,'(a)') '> Sorted file was renamed to protonated.xyz' + + write (stdout,'(a)') '> All other temporary protonate_*.xyz files are removed by default.' + if (.not.env%keepmodef) then + call rmrf('protonate_*.xyz') end if - write (stdout,'(a)') '> sorted file was renamed to protonated.xyz' !========================================================================================! return end subroutine crest_new_protonate @@ -319,6 +349,7 @@ subroutine protonation_candidates(env,mol,natp,np,protxyz,at,xyz,npnew) use crest_data use crest_parameters use strucrd,only:coord + use utilities,only:binomial,get_combinations implicit none !> INPUT type(systemdata),intent(inout) :: env @@ -328,59 +359,1038 @@ subroutine protonation_candidates(env,mol,natp,np,protxyz,at,xyz,npnew) real(wp),intent(in) :: protxyz(4,np) !> OUTPUT integer,intent(out) :: at(natp) - real(wp),intent(out) :: xyz(3,natp,np) - integer,intent(out) :: npnew + real(wp),intent(out) :: xyz(3,natp,npnew) + integer,intent(inout) :: npnew !> LOCAL - integer :: i,j,k,l,ii + integer :: i,j,jj,k,l,ii,c,nc,kk integer :: ati,ichrg,ctype + integer,allocatable :: combi(:,:),tmp(:) - if (natp .ne. mol%nat+1) then + if (natp .ne. mol%nat+env%protb%amount) then write (stdout,'(a)') 'WARNING: Inconsistent number of atoms in protonation routine' error stop end if if (env%protb%swelem) then !>--- User-defined monoatomic ion - ichrg = env%protb%swchrg + ichrg = env%protb%swchrg*env%protb%amount ati = env%protb%swat else !>--- DEFAULT: H⁺ - ichrg = 1 + ichrg = 1*env%protb%amount ati = 1 - endif + end if write (stdout,'(a,i0)') '> Increasing the molecular charge by ',ichrg call env%calc%increase_charge(ichrg) - env%chrg = env%chrg + ichrg + env%chrg = env%chrg+ichrg !>--- Check if we have some other conditions - if(any(.not.env%protb%active_lmo(:)))then - write(stdout,'(a)',advance='no') '> User-defined: IGNORING ' - if(.not.env%protb%active_lmo(1)) write(stdout,'(a)',advance='no') 'π ' - if(.not.env%protb%active_lmo(2)) write(stdout,'(a)',advance='no') 'LP ' - if(.not.env%protb%active_lmo(3)) write(stdout,'(a)',advance='no') 'deloc.π ' - write(stdout,'(a)') 'LMOs ...' - endif + if (any(.not.env%protb%active_lmo(:))) then + write (stdout,'(a)',advance='no') '> User-defined: IGNORING ' + if (.not.env%protb%active_lmo(1)) write (stdout,'(a)',advance='no') 'π ' + if (.not.env%protb%active_lmo(2)) write (stdout,'(a)',advance='no') 'LP ' + if (.not.env%protb%active_lmo(3)) write (stdout,'(a)',advance='no') 'deloc.π ' + write (stdout,'(a)') 'LMOs ...' + end if + +!>--- check combinations + k = env%protb%amount + nc = binomial(np,k) + allocate (tmp(k),combi(k,nc),source=0) + c = 0 + call get_combinations(np,k,nc,c,combi,tmp,0) !>--- Populate npnew = 0 ii = 0 - do i = 1,np + COMBILOOP: do i = 1,nc !>--- Enforce further constraints, conditions, etc. - ctype = nint(protxyz(4,i)) - if(.not.env%protb%active_lmo(ctype)) cycle !> skip unselected LMO types + ADDLOOP1: do j = 1,k + jj = combi(j,i) + ctype = nint(protxyz(4,jj)) + if (.not.env%protb%active_lmo(ctype)) cycle COMBILOOP + end do ADDLOOP1 - ii= ii + 1 !> counter of actually created structures +!>--- passed checks in ADDLOOP1 means we can add this config + ii = ii+1 !> counter of actually created structures do j = 1,mol%nat xyz(1:3,j,ii) = mol%xyz(1:3,j) at(j) = mol%at(j) end do - xyz(1:3,natp,ii) = protxyz(1:3,i) - at(natp) = ati - end do + kk = mol%nat + ADDLOOP2: do j = 1,k + jj = combi(j,i) + kk = kk+1 + xyz(1:3,kk,ii) = protxyz(1:3,jj) + at(kk) = ati + end do ADDLOOP2 + end do COMBILOOP npnew = ii + deallocate (combi,tmp) end subroutine protonation_candidates +!========================================================================================! + +subroutine protonation_prep_canonical(env,refmol,fname) + use crest_parameters + use crest_data + use strucrd + use crest_calculator + use tblite_api,only:xtblvl + use canonical_mod + use iomod,only:remove + use adjacency + use cregen_interface + implicit none + type(systemdata) :: env + type(coord),intent(in) :: refmol + character(len=*),intent(in) :: fname + + type(calcdata),allocatable :: tmpcalc + type(calculation_settings) :: ceh + type(coord),allocatable :: structures(:) + + real(wp),allocatable :: cn(:),Bmat(:,:) + integer,allocatable :: frag(:),Amat(:,:) + real(wp),allocatable :: grad(:,:) + real(wp) :: energy + integer :: nat,nall,i,j,k,io,ich,refnfrag + + type(canonical_sorter),allocatable :: canon(:) + integer,allocatable :: group(:) + character(len=*),parameter :: outfile = 'unique.xyz' + + call smallhead('Remove duplicates via canonical atom identity') + +!>--- reference molecule (unprotonated) +! call env%ref%to(refmol) !> DO NOT USE THIS, CREGEN MAY OVERWRITE + call refmol%cn_to_bond(cn,Bmat,'cov') + call wbo2adjacency(refmol%nat,Bmat,Amat,0.01_wp) + allocate (frag(refmol%nat),source=0) + call setup_fragments(refmol%nat,Amat,frag) + refnfrag = maxval(frag(:),1) + deallocate (frag,Amat,Bmat) + +!>--- read ensemble + call rdensemble(fname,nall,structures) + nat = structures(1)%nat + +!>--- run singlepoints to document WBOs and charges (doesn't need to be parallel) + allocate (canon(nall)) + + write (stdout,'(a,i0,a)') '> Setting up canonical atom order for ',nall,' structures via CN-based molecular graphs ...' + call crest_oloop_pr_progress(env,nall,0) + do i = 1,nall + call canon(i)%init(structures(i),invtype='apsp+') + call canon(i)%stereo(structures(i)) + !write(*,*) + !call canon(i)%rankprint(structures(i)) + call canon(i)%shrink() + + call crest_oloop_pr_progress(env,nall,i) + end do + call crest_oloop_pr_progress(env,nall,-1) + +!>--- grouping loop + allocate (group(nall),source=0) + do i = 1,nall + k = maxval(group(:),1) + if (group(i) == 0) then + k = k+1 + group(i) = k + !write(*,*)'structure ',i,' is the reference of ',k + end if + do j = i+1,nall + if (group(j) == 0) then + if (canon(i)%compare(canon(j))) then + group(j) = k + !write(*,*)'structure ',j,' is in group ',k + end if + end if + end do + end do + + write (stdout,'(a,i0,a)') '> ',maxval(group,1),' groups identified based on canonical atom identifier algorithm' + +!>--- more rules (setting group(i) to zero will discard the structure) + k = 0 + do i = 1,nall + if (canon(i)%nfrag .ne. refnfrag) then + group(i) = 0 + k = k+1 + end if + end do + if (k > 0) then + write (stdout,'(a,i0,a,i0,a)') '> ',k,' structures discared due to fragment change (!=',refnfrag,')' + end if + +!>--- dump to new file + open (newunit=ich,file=outfile) + GROUPLOOP: do i = 1,maxval(group,1) + STRUCTLOOP: do j = 1,nall + if (group(j) == i) then !> since the structures are energy sorted, writing the first is taking the lowest in the group + call structures(j)%append(ich) + cycle GROUPLOOP + end if + end do STRUCTLOOP + end do GROUPLOOP + close (ich) +!>--- "sort" again for printout + call newcregen(env,7,trim(outfile)) + call remove(outfile) + call rename(outfile//'.sorted',fname) + + deallocate (group) + deallocate (canon) +end subroutine protonation_prep_canonical + !========================================================================================! !>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>><<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>! +!> New implementation of DEprotonation routines +!>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>! +!========================================================================================! +subroutine crest_new_deprotonate(env,tim) +!******************************************************************** +!* Standalone runtype for deprotonating a molecule +!* +!* Input/Output: +!* env - crest's systemdata object +!* tim - timer object +!******************************************************************** + use crest_parameters + use crest_data + use crest_calculator + use strucrd + use optimize_module + use parallel_interface + use cregen_interface + use iomod + use utilities,only:binomial + implicit none + type(systemdata),intent(inout) :: env + type(timer),intent(inout) :: tim + type(coord) :: mol,molnew + integer :: i,j,k,l,io,ich,T,Tn,np + logical :: pr,wr + character(len=80) :: atmp +!========================================================================================! + type(calcdata) :: calc + real(wp) :: accuracy,etemp + + real(wp) :: energy,dip + real(wp),allocatable :: grad(:,:) + type(calcdata),allocatable :: tmpcalc + type(calcdata),allocatable :: tmpcalc_ff + type(calculation_settings) :: tmpset + integer :: natp,pstep,npnew + integer,allocatable :: atp(:) + real(wp),allocatable :: xyzp(:,:,:) + real(wp),allocatable :: ep(:) + logical,allocatable :: atlist(:) + character(len=*),parameter :: basename = 'deprotonate_' +!========================================================================================! + write (stdout,*) + !call system('figlet singlepoint') + write (stdout,*) " _ _ _ " + write (stdout,*) " __| | ___ _ __ _ __ ___ | |_ ___ _ __ __ _| |_ ___ " + write (stdout,*) " / _` |/ _ \ '_ \| '__/ _ \| __/ _ \| '_ \ / _` | __/ _ \ " + write (stdout,*) "| (_| | __/ |_) | | | (_) | || (_) | | | | (_| | || __/ " + write (stdout,*) " \__,_|\___| .__/|_| \___/ \__\___/|_| |_|\__,_|\__\___| " + write (stdout,*) " |_| " + write (stdout,*) "--------------------------------------------------------- " + write (stdout,*) " automated deprotonation site screening script " + write (stdout,*) " revised version (c) P.Pracht 2024 " + write (stdout,*) 'Cite as:' + write (stdout,*) ' P.Pracht, R.Wilcken, A.Udvarhelyi, S.Rodde, S.Grimme' + write (stdout,*) ' JCAMD, 2018, 32, 1139-1149.' + write (stdout,*) + +!========================================================================================! + call new_ompautoset(env,'max',0,T,Tn) + call ompprint_intern() +!========================================================================================! + call env%ref%to(mol) + write (stdout,*) + write (stdout,*) 'Input structure:' + call mol%append(stdout) + write (stdout,*) +!========================================================================================! +!>--- The first step is to sort the input structure so that all heavy atoms are first and +!>--- all hydrogen atoms follow after that. This is because some of the (parallel) routines +!>--- rely on identical atom order. + + write (stdout,'(a)') repeat('-',80) + write (stdout,'(a)') + write (stdout,'(a)') '> Re-sorting input structure ... ' + call deprotonation_sort(mol,np) + call mol%append(stdout) + write (stdout,*) +!>--- check + if (np == 0) then + write (stdout,*) + write (stdout,*) 'WARNING: No deprotonation sites found!' + write (stdout,*) + return + end if + +!========================================================================================! +!>--- If we reached this point, we have candidate positions for our protonation! + pstep = 0 + write (stdout,'(a)',advance='yes') '> Generating candidate structures ... ' + flush (stdout) + if (env%protb%amount > np) then + env%protb%amount = np + write (stdout,'(a,i0,a)') '> A maximum of ',np,' deprotonation sites can be used' + end if + natp = mol%nat-env%protb%amount + npnew = binomial(np,env%protb%amount) + write (stdout,'(a,i0,a)') '> Up to ',npnew,' new structures' + allocate (atp(natp),source=0) + allocate (xyzp(3,natp,npnew),ep(npnew),source=0.0_wp) + + call deprotonation_candidates(env,mol,natp,np,atp,xyzp,npnew) +!>--- NOTE: after this the global charge (env%chrg) and all charges saved in the calc levels have been decreased + + if (npnew < 1) then + write (stdout,*) + write (stdout,'(a)') '> WARNING: No remaining deprotonation sites after applying user defined conditions!' + write (stdout,'(a)') '> Modify the search criteria and check your input structure for sanity.' + return + end if + + write (atmp,'(a,i0,a)') basename,pstep,'.xyz' + write (stdout,'(a,a,a,i0,a)') '> Write ',trim(atmp),' with ',npnew,' candidates ... ' + + call wrensemble(basename//'0.xyz',natp,npnew,atp,xyzp(:,:,1:npnew)*autoaa,ep(1:npnew)) + + write (stdout,'(a)') '> done.' + write (stdout,*) + +!========================================================================================! +!>--- Optimize candidates, optional FF pre-step + if (env%protb%ffopt) then + call smallhead('Deprotomer Ensemble FF Pre-Optimization') + !>--- set up a temporary calculation object + write (stdout,'(a)') '> Removal of some hydrogen atoms may lead to initial' + write (stdout,'(a)') ' extremely high-energy candidates which can undergo unwanted' + write (stdout,'(a)') ' chemical changes in optimizations. Classical force-fields' + write (stdout,'(a)') ' with defined bond-topology can help circumvent this issue.' + write (stdout,'(a)') '> Setting up force-field structure pre-optimization ...' + allocate (tmpcalc_ff) + tmpcalc_ff%optnewinit = .true. + env%calc%optnewinit = .true. + tmpcalc_ff%optnewinit = .true. + call tmpset%create('gfnff') + tmpset%chrg = env%chrg + call tmpcalc_ff%add(tmpset) + tmpcalc_ff%maxcycle = 10000 + call tmpcalc_ff%info(stdout) + + !>--- Run optimizations + call tim%start(15,'Ensemble optimization (FF)') + call print_opt_data(tmpcalc_ff,stdout) + write (stdout,'(a,i0,a)') '> ',npnew,' structures to optimize ...' + call crest_oloop(env,natp,npnew,atp,xyzp(:,:,1:npnew),ep(1:npnew),.false.,tmpcalc_ff) + call tim%stop(15) + + deallocate (tmpcalc_ff) + + pstep = pstep+1 + write (atmp,'(a,i0,a)') basename,pstep,'.xyz' + write (stdout,'(a,a,a)') '> Write ',trim(atmp),' with optimized structures ... ' + call wrensemble(trim(atmp),natp,npnew,atp,xyzp(:,:,1:npnew)*autoaa,ep(1:npnew)) + deallocate (xyzp,atp) !> clear this space to re-use it + + !>--- sorting + write (stdout,'(a)') '> Sorting structures by energy to remove failed opts. ...' + env%ewin = 1000.0_wp + call newcregen(env,7,trim(atmp)) + call rename(trim(atmp)//'.sorted',trim(atmp)) + write (stdout,'(a)') '> Sorted file was renamed to '//trim(atmp) + write (stdout,'(a)') '> WARNING: These are force-field energies which are ' + write (stdout,'(a)') ' NOT(!) accurate for bond formation and breaking!' + write (stdout,*) + + !>--- re-read sorted ensemble + call rdensemble(trim(atmp),natp,npnew,atp,xyzp) + xyzp = xyzp*aatoau !> don't forget to restore BOHR + end if + +!========================================================================================! +!>--- H-position-only optimization (only makes sense after FF preoptimization) + if (env%protb%hnewopt.and.env%protb%ffopt) then + call smallhead('Deprotomer Ensemble Frozen-Atom Optimization') + !>--- create temporary calculation from our intended level of theory + write (stdout,'(a)') '> Setting up frozen structure optimization ...' + allocate (tmpcalc) + call env2calc(env,tmpcalc,mol) + !>--- freeze all atoms, EXCEPT the new one + allocate (atlist(natp),source=.true.) + atlist(natp) = .false. !> the new one is always last + do i = 1,natp + if (atp(i) == 1) then + atlist(i) = .false. !> additionally un-freeze all H's (this seems to be beneficial) + end if + end do + tmpcalc%nfreeze = count(atlist) + tmpcalc%optnewinit = .true. + write (stdout,'(a,i0,a)') '> ',tmpcalc%nfreeze,' frozen atoms. All H non-frozen.' + call move_alloc(atlist,tmpcalc%freezelist) + call tmpcalc%info(stdout) + + !>--- run opt + call tim%start(16,'Ensemble optimization (frozen)') + write (stdout,'(a,i0,a)') '> ',npnew,' structures to optimize ...' + call crest_oloop(env,natp,npnew,atp,xyzp(:,:,1:npnew),ep(1:npnew),.false.,tmpcalc) + call tim%stop(16) + + pstep = pstep+1 + write (atmp,'(a,i0,a)') basename,pstep,'.xyz' + write (stdout,'(a,a,a)') '> Write ',trim(atmp),' with optimized structures ... ' + call wrensemble(trim(atmp),natp,npnew,atp,xyzp(:,:,1:npnew)*autoaa,ep(1:npnew)) + deallocate (xyzp,atp) !> clear this space to re-use it + deallocate (tmpcalc) + +! call tim%start(17,'Ensemble refinement') +! call crest_refine(env,trim(atmp),trim(atmp)) +! call tim%stop(17) + + !>--- sorting + write (stdout,'(a)') '> Sorting structures by energy to remove failed opts. ...' + env%ewin = env%protb%ewin*5.0_wp !> large energy threshold + call newcregen(env,7,trim(atmp)) + call rename(trim(atmp)//'.sorted',trim(atmp)) + write (stdout,'(a)') '> Sorted file was renamed to '//trim(atmp) + write (stdout,*) + + !>--- re-read sorted ensemble + call rdensemble(trim(atmp),natp,npnew,atp,xyzp) + xyzp = xyzp*aatoau !> don't forget to restore BOHR + + end if + +!========================================================================================! +!>--- Optimize with global settings + if (env%protb%finalopt.and.env%protb%ffopt) then + call smallhead('Final Deprotomer Ensemble Optimization') + allocate (tmpcalc, source=env%calc) + call tmpcalc%info(stdout) + tmpcalc%optnewinit = .true. + call tim%start(20,'Ensemble optimization') + call print_opt_data(env%calc,stdout) + write (stdout,'(a,i0,a)') '> ',npnew,' structures to optimize ...' + call crest_oloop(env,natp,npnew,atp,xyzp(:,:,1:npnew),ep(1:npnew),.false.,tmpcalc) + call tim%stop(20) + + pstep = pstep+1 + write (atmp,'(a,i0,a)') basename,pstep,'.xyz' + write (stdout,'(a,a,a)') '> Write ',trim(atmp),' with optimized structures ... ' + call wrensemble(trim(atmp),natp,npnew,atp,xyzp(:,:,1:npnew)*autoaa,ep(1:npnew)) + deallocate (xyzp,atp) + + call tim%start(17,'Ensemble refinement') + call crest_refine(env,trim(atmp),trim(atmp)) + call tim%stop(17) + +!>--- sorting + write (stdout,'(a)') '> Sorting structures by energy ...' + env%ewin = env%protb%ewin*3.0_wp + call newcregen(env,7,trim(atmp)) + call rename(trim(atmp)//'.sorted',trim(atmp)) + end if + +!========================================================================================! +!> Remove doubly generated tautomers + call protonation_prep_canonical(env,mol,trim(atmp)) + +!========================================================================================! +!>--- move final ensemble to deprotonated.xyz + call rename(trim(atmp),'deprotonated.xyz') + write (stdout,'(a)') '> Sorted file was renamed to deprotonated.xyz' + + write (stdout,'(a)') '> All other temporary deprotonate_*.xyz files are removed by default.' + if (.not.env%keepmodef) then + call rmrf('deprotonate_*.xyz') + end if +!========================================================================================! + return +end subroutine crest_new_deprotonate + +!========================================================================================! +!========================================================================================! + +subroutine deprotonation_sort(mol,nhyd) +!******************************************************* +!* Sort "mol" so that all heavy atoms are first +!* and all hydrogens follow. Also returns the number of +!* hydrogen atoms and writes a file with the original +!* atom order +!******************************************************* + use crest_parameters + use strucrd + implicit none + type(coord),intent(inout) :: mol + integer,intent(out) :: nhyd + integer :: i,j,k,l,io,ich + integer,allocatable :: atnew(:) + real(wp),allocatable :: xyznew(:,:) + + nhyd = 0 + open (newunit=ich,file='original.atomorder') + write (ich,'(a15,a15)') '','' + + allocate (atnew(mol%nat),source=0) + allocate (xyznew(3,mol%nat),source=0.0_wp) + + k = 0 + !>--- first heavy atoms + do i = 1,mol%nat + if (mol%at(i) .ne. 1) then + k = k+1 + atnew(k) = mol%at(i) + xyznew(1:3,k) = mol%xyz(1:3,i) + write (ich,'(i15,i15)') i,k + end if + end do + !>--- then hydrogens + do i = 1,mol%nat + if (mol%at(i) .eq. 1) then + k = k+1 + nhyd = nhyd+1 + atnew(k) = mol%at(i) + xyznew(1:3,k) = mol%xyz(1:3,i) + write (ich,'(i15,i15)') i,k + end if + end do + + call move_alloc(atnew,mol%at) + call move_alloc(xyznew,mol%xyz) + + close (ich) +end subroutine deprotonation_sort + +!========================================================================================! + +subroutine deprotonation_candidates(env,mol,natp,np,at,xyz,npnew) +!******************************************************** +!* generate deprotonation/ionization candidate structures +!* The outputs are at and xyz, the latter being in Bohr +!******************************************************** + use crest_data + use crest_parameters + use strucrd,only:coord + use utilities,only:binomial,get_combinations + implicit none + !> INPUT + type(systemdata),intent(inout) :: env + type(coord),intent(in) :: mol + integer,intent(in) :: natp !> total number of atoms + integer,intent(in) :: np !> number of H⁺ + !> OUTPUT + integer,intent(out) :: at(natp) + real(wp),intent(out) :: xyz(3,natp,npnew) + integer,intent(inout) :: npnew + !> LOCAL + integer :: i,j,jj,k,l,ii,c,nc,kk + integer :: ati,ichrg,ctype,nhvy + integer,allocatable :: combi(:,:),tmp(:) + + if (natp .ne. mol%nat-env%protb%amount) then + write (stdout,'(a)') 'WARNING: Inconsistent number of atoms in deprotonation routine' + error stop + end if + + if (env%protb%swelem) then +!>--- User-defined monoatomic ion + ichrg = env%protb%swchrg*env%protb%amount + ati = env%protb%swat + else +!>--- DEFAULT: H⁺ + ichrg = 1*env%protb%amount + ati = 1 + end if + write (stdout,'(a,i0)') '> Decreasing the molecular charge by ',ichrg + call env%calc%decrease_charge(ichrg) + env%chrg = env%chrg-ichrg + +!>--- check combinations + k = env%protb%amount + nc = binomial(np,k) + allocate (tmp(k),combi(k,nc),source=0) + c = 0 + call get_combinations(np,k,nc,c,combi,tmp,0) + +!>--- Check other conditions? + ! TODO + +!>--- Populate heavy atoms + nhvy = mol%nat-np + at(1:nhvy) = mol%at(1:nhvy) + + npnew = 0 + ii = 0 + COMBILOOP: do i = 1,nc + ii = ii+1 + kk = 0 + ADDLOOP1: do j = 1,mol%nat + do l = 1,k + jj = combi(l,i)+nhvy + if (j == jj) cycle ADDLOOP1 + end do + kk = kk+1 + xyz(1:3,kk,ii) = mol%xyz(1:3,j) + at(kk) = mol%at(j) + end do ADDLOOP1 + + end do COMBILOOP + npnew = ii + + deallocate (combi,tmp) +end subroutine deprotonation_candidates + +!========================================================================================! +!>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>><<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>! +!> New implementation of tautomer routines +!>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>! +!========================================================================================! +subroutine crest_new_tautomerize(env,tim) +!******************************************************************** +!* Standalone runtype for generating molecule tautomers +!* +!* Input/Output: +!* env - crest's systemdata object +!* tim - timer object +!******************************************************************** + use crest_parameters + use crest_data + use crest_calculator + use strucrd + use optimize_module + use parallel_interface + use cregen_interface + use iomod + use utilities,only:binomial + implicit none + type(systemdata),intent(inout) :: env + type(timer),intent(inout) :: tim + type(coord) :: mol,molnew + integer :: i,j,k,l,io,ich,T,Tn,np,npadd,npremove + logical :: pr,wr + character(len=80) :: atmp +!========================================================================================! + type(calcdata) :: calc + real(wp) :: accuracy,etemp + + real(wp) :: energy,dip + real(wp),allocatable :: grad(:,:) + type(calcdata),allocatable :: tmpcalc + type(calcdata),allocatable :: tmpcalc_ff + type(calculation_settings) :: tmpset + integer :: natp,pstep,npnew + integer :: tautiter,structiter + integer,allocatable :: atp(:) + real(wp),allocatable :: xyzp(:,:,:) + real(wp),allocatable :: ep(:) + logical,allocatable :: atlist(:) + real(wp),allocatable :: protxyz(:,:) + character(len=*),parameter :: basename = 'tautomerize_' +!========================================================================================! + write (stdout,*) + !call system('figlet singlepoint') + write (stdout,*) " _ _ _ " + write (stdout,*) "| |_ __ _ _ _| |_ ___ _ __ ___ ___ _ __(_)_______ " + write (stdout,*) "| __/ _` | | | | __/ _ \| '_ ` _ \ / _ \ '__| |_ / _ \" + write (stdout,*) "| || (_| | |_| | || (_) | | | | | | __/ | | |/ / __/" + write (stdout,*) " \__\__,_|\__,_|\__\___/|_| |_| |_|\___|_| |_/___\___|" + write (stdout,*) " " + write (stdout,*) "-------------------------------------------------------" + write (stdout,*) " automated tautomer screening script " + write (stdout,*) " revised version (c) P.Pracht 2024 " + write (stdout,*) 'Cite as:' + write (stdout,*) ' P.Pracht, R.Wilcken, A.Udvarhelyi, S.Rodde, S.Grimme' + write (stdout,*) ' JCAMD, 2018, 32, 1139-1149.' + write (stdout,*) + +!========================================================================================! + call new_ompautoset(env,'max',0,T,Tn) + call ompprint_intern() +!========================================================================================! + call env%ref%to(mol) + write (stdout,*) + write (stdout,*) 'Input structure:' + call mol%append(stdout) + write (stdout,*) +!========================================================================================! +!>--- The first step is to sort the input structure so that all heavy atoms are first and +!>--- all hydrogen atoms follow after that. This is because some of the (parallel) routines +!>--- rely on identical atom order. + + write (stdout,'(a)') repeat('-',80) + write (stdout,'(a)') + write (stdout,'(a)') '> Re-sorting input structure ... ' + call deprotonation_sort(mol,npremove) + call mol%append(stdout) + write (stdout,*) +!>--- check + if (npremove == 0) then + write (stdout,*) + write (stdout,*) 'WARNING: No deprotonation sites found, therefore no tautomer search possible!' + write (stdout,*) + return + end if + +!========================================================================================! +!========================================================================================! +!>--- Tautomerization can be run iteratively to do further permutations +! TAUTLOOP : do tautiter=1,env%protb%iter +!========================================================================================! +!========================================================================================! +!>--- Then, we need to perfom a LMO calculation to identify suitable protonation sites +!>--- in this version of the program this step is always done with GFN0-xTB. + + call tim%start(14,'LMO center calculation') + write (stdout,'(a)') repeat('-',80) + write (stdout,'(a)') + write (stdout,'(a)',advance='no') '> Setting up GFN0-xTB for LMO center calculation ... ' + flush (stdout) + + allocate (grad(3,mol%nat),source=0.0_wp) +!>--- GFN0 job adapted from global settings + allocate (tmpcalc) + call env2calc(env,tmpcalc,mol) + tmpcalc%calcs(1)%id = jobtype%gfn0 + tmpcalc%calcs(1)%rdwbo = .true. + tmpcalc%calcs(1)%getlmocent = .true. + tmpcalc%calcs(1)%chrg = env%chrg + tmpcalc%ncalculations = 1 + write (stdout,'(a)') 'done.' +!>--- and then start it + write (stdout,'(a)',advance='yes') '> Performing singlepoint calculation ... ' + flush (stdout) +!>>>>>>>>>>>>>>>>>>>>>>><<<<<<<<<<<<<<<<<<<<>>>>>>>>>>>>>>>>>>>>>><<<<<<<<<<<<<<<<<<<<>>>>>>>>>>>>>>>>>>>>>><<<<<<<<<<<<<<<<<<<<>>>>>>>>>>>>>>>>>>>>>><<<<<<<<<<<<<<<<<<<< done.' + write (atmp,'(a)') '> Total wall time for calculations' + call tim%write_timing(stdout,14,trim(atmp),.true.) + write (stdout,'(a)') repeat('-',80) + write (stdout,*) + if (io /= 0) then + write (stdout,*) + write (stdout,*) 'WARNING: Calculation exited with error!' + end if +!>--- check LMO center + npadd = tmpcalc%calcs(1)%nprot + if (npadd > 0) then + write (stdout,'(a,i0,a)') '> ',np,' π- or LP-centers identified as protonation candidates:' + call move_alloc(tmpcalc%calcs(1)%protxyz,protxyz) + write (stdout,'(1x,a5,1x,a,5x,a)') 'LMO','type','center(xyz/Ang)' + do i = 1,npadd + select case (nint(protxyz(4,i))) + case (1) + write (stdout,'(1x,i5,1x,a,3F12.5)') i,'LP ',protxyz(1:3,i)*autoaa + case (2) + write (stdout,'(1x,i5,1x,a,3F12.5)') i,'π ',protxyz(1:3,i)*autoaa + case (3) + write (stdout,'(1x,i5,1x,a,3F12.5)') i,'del.π',protxyz(1:3,i)*autoaa + case default + write (stdout,'(1x,i5,1x,a,3F12.5)') i,'??? ',protxyz(1:3,i)*autoaa + end select + end do + else + write (stdout,*) + write (stdout,*) 'WARNING: No suitable protonation sites found!' + write (stdout,*) ' Confirm whether you expect π- or LP-centers for your molecule!' + write (stdout,*) + return + end if + deallocate (tmpcalc) + deallocate (grad) + +!========================================================================================! +!>--- If we reached this point, we have candidate positions for our protonation! + pstep = 0 + write (stdout,'(a)',advance='yes') '> Generating candidate structures ... ' + flush (stdout) + !> no change in atom numbers for tautomers! + natp = mol%nat + !> however, the number of permutations can get gigantic! + !npnew = binomial(npadd,env%protb%amount)*binomial(npremove,env%protb%amount) + !> for now, refer to a single-tautomer-permutation (moving one H) + npnew = npadd*npremove + write (stdout,'(a,i0,a)') '> Up to ',npnew,' new structures' + allocate (atp(natp),source=0) + allocate (xyzp(3,natp,npnew),ep(npnew),source=0.0_wp) + + !> generate initial structures + call tautomer_candidates(env,mol,natp,npadd,npremove,protxyz,atp,xyzp,npnew) + + if (npnew < 1) then + write (stdout,*) + write (stdout,'(a)') '> WARNING: No remaining tautomer candidates after applying user defined conditions!' + write (stdout,'(a)') '> Modify the search criteria and check your input structure for sanity.' + return + end if + + write (atmp,'(a,i0,a)') basename,pstep,'.xyz' + write (stdout,'(a,a,a,i0,a)') '> Write ',trim(atmp),' with ',npnew,' candidates ... ' + + call wrensemble(basename//'0.xyz',natp,npnew,atp,xyzp(:,:,1:npnew)*autoaa,ep(1:npnew)) + + write (stdout,'(a)') '> done.' + write (stdout,*) + +!========================================================================================! +!>--- Optimize candidates, optional FF pre-step + if (env%protb%ffopt) then + call smallhead('Tautomer Ensemble FF Pre-Optimization') + !>--- set up a temporary calculation object + write (stdout,'(a)') '> Removal/addition of hydrogen atoms may lead to initial' + write (stdout,'(a)') ' extremely high-energy candidates which can undergo unwanted' + write (stdout,'(a)') ' chemical changes in optimizations. Classical force-fields' + write (stdout,'(a)') ' with defined bond-topology can help circumvent this issue.' + write (stdout,'(a)') '> Setting up force-field structure pre-optimization ...' + allocate (tmpcalc_ff) + tmpcalc_ff%optnewinit = .true. + env%calc%optnewinit = .true. + tmpcalc_ff%optnewinit = .true. + call tmpset%create('gfnff') + tmpset%chrg = env%chrg + call tmpcalc_ff%add(tmpset) + tmpcalc_ff%maxcycle = 10000 + tmpcalc_ff%anopt=.true. + call tmpcalc_ff%info(stdout) + + !>--- Run optimizations + call tim%start(15,'Ensemble optimization (FF)') + call print_opt_data(tmpcalc_ff,stdout) + write (stdout,'(a,i0,a)') '> ',npnew,' structures to optimize ...' + call crest_oloop(env,natp,npnew,atp,xyzp(:,:,1:npnew),ep(1:npnew),.false.,tmpcalc_ff) + call tim%stop(15) + + deallocate (tmpcalc_ff) + + pstep = pstep+1 + write (atmp,'(a,i0,a)') basename,pstep,'.xyz' + write (stdout,'(a,a,a)') '> Write ',trim(atmp),' with optimized structures ... ' + call wrensemble(trim(atmp),natp,npnew,atp,xyzp(:,:,1:npnew)*autoaa,ep(1:npnew)) + deallocate (xyzp,atp) !> clear this space to re-use it + + !>--- sorting + write (stdout,'(a)') '> Sorting structures by energy to remove failed opts. ...' + env%ewin = 1000.0_wp + call newcregen(env,7,trim(atmp)) + call rename(trim(atmp)//'.sorted',trim(atmp)) + write (stdout,'(a)') '> Sorted file was renamed to '//trim(atmp) + write (stdout,'(a)') '> WARNING: These are force-field energies which are ' + write (stdout,'(a)') ' NOT(!) accurate for bond formation and breaking!' + write (stdout,*) + + !> Remove doubly generated tautomers + call protonation_prep_canonical(env,mol,trim(atmp)) + + !>--- re-read sorted ensemble + call rdensemble(trim(atmp),natp,npnew,atp,xyzp) + xyzp = xyzp*aatoau !> don't forget to restore BOHR + end if + +!========================================================================================! +!>--- H-position-only optimization (only makes sense after FF preoptimization) + if (env%protb%hnewopt.and.env%protb%ffopt) then + call smallhead('Tautomer Ensemble Frozen-Atom Optimization') + !>--- create temporary calculation from our intended level of theory + write (stdout,'(a)') '> Setting up frozen structure optimization ...' + allocate (tmpcalc) + call env2calc(env,tmpcalc,mol) + !>--- freeze all atoms, EXCEPT the new one + allocate (atlist(natp),source=.true.) + atlist(natp) = .false. !> the new one is always last + do i = 1,natp + if (atp(i) == 1) then + atlist(i) = .false. !> additionally un-freeze all H's (this seems to be beneficial) + end if + end do + tmpcalc%nfreeze = count(atlist) + tmpcalc%optnewinit = .true. + write (stdout,'(a,i0,a)') '> ',tmpcalc%nfreeze,' frozen atoms. All H non-frozen.' + call move_alloc(atlist,tmpcalc%freezelist) + call tmpcalc%info(stdout) + + !>--- run opt + call tim%start(16,'Ensemble optimization (frozen)') + write (stdout,'(a,i0,a)') '> ',npnew,' structures to optimize ...' + call crest_oloop(env,natp,npnew,atp,xyzp(:,:,1:npnew),ep(1:npnew),.false.,tmpcalc) + call tim%stop(16) + + pstep = pstep+1 + write (atmp,'(a,i0,a)') basename,pstep,'.xyz' + write (stdout,'(a,a,a)') '> Write ',trim(atmp),' with optimized structures ... ' + call wrensemble(trim(atmp),natp,npnew,atp,xyzp(:,:,1:npnew)*autoaa,ep(1:npnew)) + deallocate (xyzp,atp) !> clear this space to re-use it + deallocate (tmpcalc) + +! call tim%start(17,'Ensemble refinement') +! call crest_refine(env,trim(atmp),trim(atmp)) +! call tim%stop(17) + + !>--- sorting + write (stdout,'(a)') '> Sorting structures by energy to remove failed opts. ...' + env%ewin = env%protb%ewin*3.0_wp !> large energy threshold + call newcregen(env,7,trim(atmp)) + call rename(trim(atmp)//'.sorted',trim(atmp)) + write (stdout,'(a)') '> Sorted file was renamed to '//trim(atmp) + write (stdout,*) + + !>--- re-read sorted ensemble + call rdensemble(trim(atmp),natp,npnew,atp,xyzp) + xyzp = xyzp*aatoau !> don't forget to restore BOHR + + end if + +!========================================================================================! +!>--- Optimize with global settings + if (env%protb%finalopt.and.env%protb%ffopt) then + call smallhead('Final Tautomer Ensemble Optimization') + allocate (tmpcalc) + call env2calc(env,tmpcalc,mol) + call tmpcalc%info(stdout) + tmpcalc%optnewinit = .true. + call tim%start(20,'Ensemble optimization') + call print_opt_data(env%calc,stdout) + write (stdout,'(a,i0,a)') '> ',npnew,' structures to optimize ...' + call crest_oloop(env,natp,npnew,atp,xyzp(:,:,1:npnew),ep,.false.,tmpcalc) + call tim%stop(20) + + pstep = pstep+1 + write (atmp,'(a,i0,a)') basename,pstep,'.xyz' + write (stdout,'(a,a,a)') '> Write ',trim(atmp),' with optimized structures ... ' + call wrensemble(trim(atmp),natp,npnew,atp,xyzp(:,:,1:npnew)*autoaa,ep(1:npnew)) + deallocate (xyzp,atp) + + call tim%start(17,'Ensemble refinement') + call crest_refine(env,trim(atmp),trim(atmp)) + call tim%stop(17) + +!>--- sorting + write (stdout,'(a)') '> Sorting structures by energy ...' + env%ewin = env%protb%ewin*2.0_wp + call newcregen(env,7,trim(atmp)) + call rename(trim(atmp)//'.sorted',trim(atmp)) + end if + +!========================================================================================! +!> Remove doubly generated tautomers + call protonation_prep_canonical(env,mol,trim(atmp)) + +!========================================================================================! +!========================================================================================! +! enddo TAUTLOOP +!========================================================================================! +!========================================================================================! +!>--- move final ensemble to deprotonated.xyz + call rename(trim(atmp),'tautomers.xyz') + write (stdout,'(a)') '> Sorted file was renamed to tautomers.xyz' + + write (stdout,'(a)') '> All other temporary tautomerize_*.xyz files are removed by default.' + if (.not.env%keepmodef) then + call rmrf('tautomerize_*.xyz') + end if + + return +end subroutine crest_new_tautomerize + +!=========================================================================================! + +subroutine tautomer_candidates(env,mol,natp,npadd,npremove,protxyz,at,xyz,npnew) +!******************************************************** +!* generate tautomer candidate structures +!* The outputs are at and xyz, the latter being in Bohr +!******************************************************** + use crest_data + use crest_parameters + use strucrd,only:coord + use utilities,only:binomial,get_combinations + implicit none + !> INPUT + type(systemdata),intent(inout) :: env + type(coord),intent(in) :: mol + integer,intent(in) :: natp + integer,intent(in) :: npadd,npremove + real(wp),intent(in) :: protxyz(4,npadd) + !> OUTPUT + integer,intent(out) :: at(natp) + real(wp),intent(out) :: xyz(3,natp,npnew) + integer,intent(inout) :: npnew + !> LOCAL + integer :: i,j,jj,k,l,ii,c,nc,kk,nhvy + integer :: ati,ichrg,ctype + integer,allocatable :: combiadd(:,:),tmpadd(:),combiremove(:,:),tmpremove(:) + + if (natp .ne. mol%nat) then + write (stdout,'(a)') 'WARNING: Inconsistent number of atoms in protonation routine' + error stop + end if + + ati = 1 !> always refer to Hydrogen for tautomers + +!>--- Check if we have some other conditions + if (any(.not.env%protb%active_lmo(:))) then + write (stdout,'(a)',advance='no') '> User-defined: IGNORING ' + if (.not.env%protb%active_lmo(1)) write (stdout,'(a)',advance='no') 'π ' + if (.not.env%protb%active_lmo(2)) write (stdout,'(a)',advance='no') 'LP ' + if (.not.env%protb%active_lmo(3)) write (stdout,'(a)',advance='no') 'deloc.π ' + write (stdout,'(a)') 'LMOs ...' + end if + + nc = npadd*npremove + nhvy = mol%nat-npremove + +!>--- Populate + npnew = 0 + ii = 0 + COMBILOOP: do i = 1,npremove + l = i+nhvy + ADDLOOP1: do jj = 1,npadd + ctype = nint(protxyz(4,jj)) +!>--- Enforce further constraints, conditions, etc. + if (.not.env%protb%active_lmo(ctype)) cycle COMBILOOP + +!>--- passed checks means we can add this config + ii = ii+1 !> counter of actually created structures + kk = 0 + do j = 1,nhvy !> first all heavy atoms (xyz should be sorted!) + kk=kk+1 + xyz(1:3,kk,ii) = mol%xyz(1:3,j) + at(kk) = mol%at(j) + end do + ADDLOOP2: do j = nhvy+1,natp !> then all "old" H except the moving one + if (j == l) cycle ADDLOOP2 !> cycle the moving H + kk = kk+1 + xyz(1:3,kk,ii) = mol%xyz(1:3,j) + at(kk) = ati + end do ADDLOOP2 + !> finally, add the new H from the protonation center (it is always the last H) + xyz(1:3,natp,ii) = protxyz(1:3,jj) + at(natp) = ati + end do ADDLOOP1 + end do COMBILOOP + npnew = ii + +end subroutine tautomer_candidates + +!========================================================================================! +!>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>>><<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<<0)then - calc%etmp = 0.0_wp - calc%grdtmp = 0.0_wp - endif + if (n > 0) then + calc%etmp = 0.0_wp + calc%grdtmp = 0.0_wp + end if !$omp end critical !************************************** @@ -260,13 +260,13 @@ subroutine engrad_mol(mol,calc,energy,gradient,iostatus) !!$omp parallel & !!$omp shared(calc%cons,mol,n,energy,gradient) & - !!$omp private(efix,i,calc%grdfix) + !!$omp private(efix,i,calc%grdfix) do i = 1,calc%nconstraints efix = 0.0_wp calc%grdfix = 0.0_wp - if(calc%nfreeze > 0)then - call calc%cons(i)%addfreeze(calc%freezelist) - endif + if (calc%nfreeze > 0) then + call calc%cons(i)%addfreeze(calc%freezelist) + end if if (calc%cons(i)%type >= 0) then !>--- structural constraints call calc_constraint(mol%nat,mol%xyz,calc%cons(i),efix,calc%grdfix) @@ -363,13 +363,13 @@ subroutine potential_core(molptr,calc,id,iostatus) !> ORCA-style SPs call orca_engrad(molptr,calc%calcs(id),calc%etmp(id),calc%grdtmp(:,1:pnat,id),iostatus) - case (jobtype%lj) + case (jobtype%lj) !> Lennard-Jones potential calculation if (allocated(calc%calcs(id)%other)) then read (calc%calcs(id)%other,*) dum1,dum2 else dum2 = 3.4_wp !> Argon-LJ distance (σ) in Angstroem - dum1 = 0.238129_wp/627.50947428_wp !> Argon-LJ energy (ε) in atomic units + dum1 = 0.238129_wp/627.50947428_wp !> Argon-LJ energy (ε) in atomic units end if call lj_engrad(molptr%nat,molptr%xyz*autoaa,dum1,dum2, & & calc%etmp(id),calc%grdtmp(:,1:pnat,id)) @@ -386,52 +386,62 @@ end subroutine potential_core !========================================================================================! !========================================================================================! - subroutine numgrad(mol,calc,angrad) + subroutine numgrad(mol,calc,angrad,numgradient) !******************************************************* !* subroutine numgrad !* routine to perform a numerical gradient calculation !******************************************************* implicit none - - type(coord) :: mol - type(calcdata) :: calc - real(wp) :: angrad(3,mol%nat) + type(coord),intent(inout) :: mol + type(calcdata),intent(inout) :: calc + real(wp),intent(in),optional :: angrad(3,mol%nat) + real(wp),allocatable,intent(out),optional :: numgradient(:,:) integer :: i,j,k,l,ich,och,io real(wp) :: energy,el,er real(wp),allocatable :: grad(:,:) - real(wp),allocatable :: numgrd(:,:) - real(wp),parameter :: step = 0.00001_wp,step2 = 0.5_wp/step + real(wp),allocatable :: ngrd(:,:) + real(wp),parameter :: step = 0.0005_wp + real(wp),parameter :: step2 = 0.5_wp/step allocate (grad(3,mol%nat),source=0.0_wp) - allocate (numgrd(3,mol%nat),source=0.0_wp) + allocate (ngrd(3,mol%nat),source=0.0_wp) do i = 1,mol%nat do j = 1,3 + call calc%dealloc_params() mol%xyz(j,i) = mol%xyz(j,i)+step call engrad(mol,calc,er,grad,io) + call calc%dealloc_params() mol%xyz(j,i) = mol%xyz(j,i)-2*step call engrad(mol,calc,el,grad,io) mol%xyz(j,i) = mol%xyz(j,i)+step - numgrd(j,i) = step2*(er-el) + ngrd(j,i) = step2*(er-el) end do end do - write (stdout,*) - write (stdout,*) 'Numerical Gradient:' - do i = 1,mol%nat - write (*,'(3f18.8)') numgrd(1:3,i) - end do + if (present(angrad)) then + write (stdout,*) + write (stdout,*) 'Numerical Gradient:' + do i = 1,mol%nat + write (*,'(3f18.8)') ngrd(1:3,i) + end do - write (stdout,*) - write (stdout,*) 'Gradient Difference:' - do i = 1,mol%nat - write (stdout,'(3f18.8)') numgrd(1:3,i)-angrad(1:3,i) - end do + write (stdout,*) + write (stdout,*) 'Gradient Difference:' + do i = 1,mol%nat + write (stdout,'(3f18.8)') ngrd(1:3,i)-angrad(1:3,i) + end do + end if - deallocate (numgrd,grad) + if (present(numgradient)) then + call move_alloc(ngrd,numgradient) + else + deallocate (ngrd) + end if + deallocate (grad) return end subroutine numgrad @@ -537,7 +547,7 @@ subroutine numhess2(nat,at,xyz,calc,hess,io) mol%nat = nat mol%at = at mol%xyz = xyz - + allocate (gradr(3,mol%nat),source=0.0_wp) !dummy allocate (gradl(3,mol%nat),source=0.0_wp) !dummy @@ -546,15 +556,15 @@ subroutine numhess2(nat,at,xyz,calc,hess,io) !>--- prepare potential dipole gradient readout rddipoles = (any(calc%calcs(:)%rddip)) - if(rddipoles)then - do m=1,calc%ncalculations - if(calc%calcs(m)%rddip)then - calc%calcs(m)%rddipgrad = .true. - if(allocated(calc%calcs(m)%dipgrad)) deallocate(calc%calcs(m)%dipgrad) - allocate(calc%calcs(m)%dipgrad(3,nat*3)) - endif - enddo - endif + if (rddipoles) then + do m = 1,calc%ncalculations + if (calc%calcs(m)%rddip) then + calc%calcs(m)%rddipgrad = .true. + if (allocated(calc%calcs(m)%dipgrad)) deallocate (calc%calcs(m)%dipgrad) + allocate (calc%calcs(m)%dipgrad(3,nat*3)) + end if + end do + end if !>--- actual numerical Hessian loop do i = 1,mol%nat @@ -564,13 +574,13 @@ subroutine numhess2(nat,at,xyz,calc,hess,io) call engrad(mol,calc,er,gradr,io) gradr_tmp = calc%grdtmp - if(rddipoles) call get_dipoles(calc,dipr) + if (rddipoles) call get_dipoles(calc,dipr) mol%xyz(j,i) = mol%xyz(j,i)-2.0_wp*step call engrad(mol,calc,el,gradl,io) gradl_tmp = calc%grdtmp - if(rddipoles) call get_dipoles(calc,dipl) + if (rddipoles) call get_dipoles(calc,dipl) mol%xyz(j,i) = mol%xyz(j,i)+step @@ -585,13 +595,13 @@ subroutine numhess2(nat,at,xyz,calc,hess,io) end do !>--- create dipole gradients - if(rddipoles)then - do m=1,calc%ncalculations - if(calc%calcs(m)%rddip)then - calc%calcs(m)%dipgrad(1:3, ii) = (dipr(1:3,m) - dipl(1:3,m)) * step2 - endif - enddo - endif + if (rddipoles) then + do m = 1,calc%ncalculations + if (calc%calcs(m)%rddip) then + calc%calcs(m)%dipgrad(1:3,ii) = (dipr(1:3,m)-dipl(1:3,m))*step2 + end if + end do + end if end do end do @@ -609,8 +619,8 @@ subroutine numhess2(nat,at,xyz,calc,hess,io) call engrad(mol,calc,el,gradl,io) !>- to get the gradient of the non-displaced s - if(allocated(dipl)) deallocate(dipl) - if(allocated(dipr)) deallocate(dipr) + if (allocated(dipl)) deallocate (dipl) + if (allocated(dipr)) deallocate (dipr) deallocate (gradl_tmp,gradr_tmp) deallocate (gradl,gradr) call mol%deallocate() @@ -652,18 +662,18 @@ subroutine constrhess(nat,at,xyz,calc,phess) dummycalc%id = -1000 dummycalc%ncalculations = 0 dummycalc%pr_energies = .false. - + !> copy the constraints - dummycalc%nfreeze = calc%nfreeze + dummycalc%nfreeze = calc%nfreeze dummycalc%nconstraints = ncons !$omp critical - allocate(dummycalc%cons( ncons )) - do i=1,ncons - dummycalc%cons(i) = calc%cons(i) - enddo - if(calc%nfreeze > 0)then - dummycalc%freezelist = calc%freezelist - endif + allocate (dummycalc%cons(ncons)) + do i = 1,ncons + dummycalc%cons(i) = calc%cons(i) + end do + if (calc%nfreeze > 0) then + dummycalc%freezelist = calc%freezelist + end if n3 = nat*3 allocate (hess(n3,n3),source=0.0_wp) !$omp end critical @@ -677,7 +687,7 @@ subroutine constrhess(nat,at,xyz,calc,phess) phess(k) = phess(k)+0.5_wp*(hess(j,i)+hess(i,j)) end do end do - + deallocate (hess) return end subroutine constrhess @@ -706,7 +716,7 @@ subroutine calc_print_energies(calc,energy,energies,gnorm,chnl) write (atmp,'(f20.12)') energies(i) btmp = btmp//atmp end do - write(atmp,'(e20.5)') gnorm + write (atmp,'(e20.5)') gnorm btmp = btmp//atmp if (present(chnl)) then write (chnl,'(a)') btmp diff --git a/src/calculator/tblite_api.F90 b/src/calculator/tblite_api.F90 index 3e7a4edf..d16e5c56 100644 --- a/src/calculator/tblite_api.F90 +++ b/src/calculator/tblite_api.F90 @@ -32,8 +32,8 @@ module tblite_api use tblite_wavefunction_type,only:wavefunction_type,new_wavefunction use tblite_wavefunction,only:sad_guess,eeq_guess use tblite_xtb,xtb_calculator => xtb_calculator - use tblite_xtb_calculator, only: new_xtb_calculator - use tblite_param, only : param_record + use tblite_xtb_calculator,only:new_xtb_calculator + use tblite_param,only:param_record use tblite_results,only:tblite_resultstype => results_type use tblite_wavefunction_mulliken,only:get_molecular_dipole_moment use tblite_ceh_singlepoint,only:ceh_singlepoint @@ -152,17 +152,17 @@ subroutine tblite_setup(mol,chrg,uhf,lvl,etemp,tblite) call new_ceh_calculator(tblite%calc,mctcmol,error) !> doesn't matter but needs initialization case (xtblvl%param) if (pr) call tblite%ctx%message("tblite> setting up xtb calculator from parameter file") - if(allocated(tblite%paramfile))then + if (allocated(tblite%paramfile)) then call tblite_read_param_record(tblite%paramfile,param,io) - call new_xtb_calculator(tblite%calc, mctcmol, param, error) - if(allocated(error))then - write(stdout,*) 'Could not read tblite parameter file '//tblite%paramfile + call new_xtb_calculator(tblite%calc,mctcmol,param,error) + if (allocated(error)) then + write (stdout,*) 'Could not read tblite parameter file '//tblite%paramfile error stop - endif + end if else if (pr) call tblite%ctx%message("tblite> parameter file does not exist, defaulting to GFN2-xTB") call new_gfn2_calculator(tblite%calc,mctcmol,error) - endif + end if case default call tblite%ctx%message("Error: Unknown method in tblite!") error stop @@ -189,8 +189,9 @@ subroutine tblite_add_solv(mol,chrg,uhf,tblite,smodel,solvent) #ifdef WITH_TBLITE use tblite_container,only:container_type use tblite_solvation,only:new_solvation,tblite_solvation_type => solvation_type, & - & solvent_data,get_solvent_data,solvation_input, & - & cpcm_input,alpb_input,alpb_solvation + & solvent_data,get_solvent_data,solvation_input, & + & cpcm_input,alpb_input,alpb_solvation, & + & cds_input,new_solvation_cds,shift_input,new_solvation_shift #endif implicit none type(coord),intent(in) :: mol @@ -207,7 +208,10 @@ subroutine tblite_add_solv(mol,chrg,uhf,tblite,smodel,solvent) class(tblite_solvation_type),allocatable :: solv type(solvation_input),allocatable :: solv_inp type(solvent_data) :: solv_data - character(len=:),allocatable :: str,solvdum + type(alpb_input) :: alpb_tmp + type(cds_input) :: cds_tmp + type(shift_input) :: shift_tmp + character(len=:),allocatable :: str,solvdum,method logical :: pr if (.not.allocated(smodel).or..not.allocated(solvent)) then @@ -216,10 +220,16 @@ subroutine tblite_add_solv(mol,chrg,uhf,tblite,smodel,solvent) pr = (tblite%ctx%verbosity > 0) !>--- some tblite calculators have nothing to do with implicit solvation - if (tblite%lvl > 3 .and. tblite%lvl.ne.xtblvl%param) then + if (tblite%lvl > 3.and.tblite%lvl .ne. xtblvl%param) then if (pr) call tblite%ctx%message("tblite> skipping implicit solvation setup for this potential") return end if + select case (tblite%lvl) + case (xtblvl%gfn1) + method = 'gfn1' + case (xtblvl%gfn2) + method = 'gfn2' + end select !>--- make an mctcmol object from mol call tblite_mol2mol(mol,chrg,uhf,mctcmol) @@ -240,32 +250,77 @@ subroutine tblite_add_solv(mol,chrg,uhf,tblite,smodel,solvent) select case (trim(smodel)) case ('gbsa') if (pr) call tblite%ctx%message("tblite> using GBSA/"//solvdum) - allocate (solv_inp%alpb) - solv_inp%alpb = alpb_input(solv_data%eps,alpb=.false.) + alpb_tmp%dielectric_const = solv_data%eps + alpb_tmp%alpb=.false. + alpb_tmp%method=method + alpb_tmp%solvent=solv_data%solvent + alpb_tmp%xtb=.true. + allocate (solv_inp%alpb, source=alpb_tmp) + cds_tmp%alpb=.false. + cds_tmp%solvent=solv_data%solvent + cds_tmp%method=method + allocate (solv_inp%cds, source=cds_tmp) + shift_tmp%alpb=.false. + shift_tmp%solvent=solv_data%solvent + shift_tmp%method=method + allocate (solv_inp%shift, source=shift_tmp) case ('cpcm') if (pr) call tblite%ctx%message("tblite> using CPCM/"//solvdum) allocate (solv_inp%cpcm) solv_inp%cpcm = cpcm_input(solv_data%eps) case ('alpb') if (pr) call tblite%ctx%message("tblite> using ALPB/"//solvdum) - allocate (solv_inp%alpb) - solv_inp%alpb = alpb_input(solv_data%eps,alpb=.true.) + alpb_tmp%dielectric_const = solv_data%eps + alpb_tmp%alpb=.true. + alpb_tmp%method=method + alpb_tmp%solvent=solv_data%solvent + alpb_tmp%xtb=.true. + allocate (solv_inp%alpb, source=alpb_tmp) + cds_tmp%alpb=.true. + cds_tmp%solvent=solv_data%solvent + cds_tmp%method=method + allocate (solv_inp%cds, source=cds_tmp) + shift_tmp%alpb=.true. + shift_tmp%solvent=solv_data%solvent + shift_tmp%method=method + allocate (solv_inp%shift, source=shift_tmp) case default if (pr) call tblite%ctx%message("tblite> Unknown tblite implicit solvation model!") return end select + str = 'tblite> WARNING: implicit solvation energies are not entirely '// & &'consistent with the xtb implementation.' if (pr) call tblite%ctx%message(str) -!>--- add to calculator - call new_solvation(solv,mctcmol,solv_inp,error) +!>--- add electrostatic (Born part) to calculator + call new_solvation(solv,mctcmol,solv_inp,error,method) if (allocated(error)) then if (pr) call tblite%ctx%message("tblite> failed to set up tblite implicit solvation!") return end if call move_alloc(solv,cont) call tblite%calc%push_back(cont) +!>--- add hbond and dispersion pert to calculator + if (allocated(solv_inp%cds)) then + block + class(tblite_solvation_type),allocatable :: cds + call new_solvation_cds(cds,mctcmol,solv_inp,error,method) + if (allocated(error)) return + call move_alloc(cds,cont) + call tblite%calc%push_back(cont) + end block + end if +!>--- add gsolv shift to calculator + if (allocated(solv_inp%shift)) then + block + class(tblite_solvation_type),allocatable :: shift + call new_solvation_shift(shift,solv_inp,error,method) + if (allocated(error)) return + call move_alloc(shift,cont) + call tblite%calc%push_back(cont) + end block + end if deallocate (solv_inp) @@ -302,11 +357,11 @@ subroutine tblite_singlepoint(mol,chrg,uhf,tblite,energy,gradient,iostatus) energy = 0.0_wp gradient(:,:) = 0.0_wp pr = (tblite%ctx%verbosity > 0) - if(tblite%ctx%verbosity>1)then + if (tblite%ctx%verbosity > 1) then verbosity = tblite%ctx%verbosity else verbosity = 0 - endif + end if !>--- make an mctcmol object from mol call tblite_mol2mol(mol,chrg,uhf,mctcmol) @@ -320,8 +375,8 @@ subroutine tblite_singlepoint(mol,chrg,uhf,tblite,energy,gradient,iostatus) case (xtblvl%ceh) call ceh_singlepoint(tblite%ctx,tblite%calc,mctcmol,tblite%wfn, & & tblite%accuracy,verbosity) - case(xtblvl%eeq) - call eeq_guess(mctcmol, tblite%calc, tblite%wfn) + case (xtblvl%eeq) + call eeq_guess(mctcmol,tblite%calc,tblite%wfn) end select if (tblite%ctx%failed()) then @@ -409,25 +464,25 @@ subroutine tblite_getwbos(tblite,nat,wbo) case default nao = tblite%calc%bas%nao - allocate(Pa(nao,nao),Pb(nao,nao)) - call split_foccab(nao,tblite%wfn%focc, tblite%wfn%nel(1), tblite%wfn%nel(2), & - & focca, foccb) + allocate (Pa(nao,nao),Pb(nao,nao)) + call split_foccab(nao,tblite%wfn%focc,tblite%wfn%nel(1),tblite%wfn%nel(2), & + & focca,foccb) call density_matrix(nao,focca,tblite%wfn%coeff(:,:,1),Pa) call density_matrix(nao,foccb,tblite%wfn%coeff(:,:,1),Pb) - call get_wbo(nat, nao, Pa,Pb, tblite%res%overlap, tblite%calc%bas%ao2at, wbo) + call get_wbo(nat,nao,Pa,Pb,tblite%res%overlap,tblite%calc%bas%ao2at,wbo) case (xtblvl%ceh) - !> no external access to the overlap in CEH, hence use the Wiberg BO with S=I + !> no external access to the overlap in CEH, hence use the Wiberg BO with S=I nao = tblite%calc%bas%nao - allocate(S(nao,nao), source=0.0_wp) - do i=1,nao + allocate (S(nao,nao),source=0.0_wp) + do i = 1,nao S(i,i) = 1.0_wp - enddo + end do call get_wbo_rhf(nat,tblite%calc%bas%nao,tblite%wfn%density, & & S,tblite%calc%bas%ao2at,wbo) wbo = wbo*2.0_wp !> somehow this is much better - case( xtblvl%eeq ) + case (xtblvl%eeq) wbo = 0.0_wp end select #endif @@ -477,37 +532,37 @@ end subroutine tblite_getdipole !========================================================================================! #ifdef WITH_TBLITE -subroutine tblite_read_param_record(paramfile,param,io) - use tomlf - implicit none - character(len=*),intent(in) :: paramfile - type(param_record),intent(out) :: param - integer,intent(out) :: io - type(error_type),allocatable :: error - type(toml_table),allocatable :: table - type(toml_error),allocatable :: terror - type(toml_context) :: tcontext - logical,parameter :: color = .true. - - io=1 - - call toml_load(table,paramfile,error=terror,context=tcontext, & - & config=toml_parser_config(color=color)) - if(allocated(terror))then - io=1 - return - endif - - call param%load_from_toml(table,error) - - if(allocated(error))then - io=1 - else - io=0 - endif - if(allocated(table))deallocate(table) - -end subroutine tblite_read_param_record + subroutine tblite_read_param_record(paramfile,param,io) + use tomlf + implicit none + character(len=*),intent(in) :: paramfile + type(param_record),intent(out) :: param + integer,intent(out) :: io + type(error_type),allocatable :: error + type(toml_table),allocatable :: table + type(toml_error),allocatable :: terror + type(toml_context) :: tcontext + logical,parameter :: color = .true. + + io = 1 + + call toml_load(table,paramfile,error=terror,context=tcontext, & + & config=toml_parser_config(color=color)) + if (allocated(terror)) then + io = 1 + return + end if + + call param%load_from_toml(table,error) + + if (allocated(error)) then + io = 1 + else + io = 0 + end if + if (allocated(table)) deallocate (table) + + end subroutine tblite_read_param_record #endif !========================================================================================! diff --git a/src/canonical.f90 b/src/canonical.f90 new file mode 100644 index 00000000..8c88a233 --- /dev/null +++ b/src/canonical.f90 @@ -0,0 +1,737 @@ + +module canonical_mod +!************************************************************************* +!* Implementation of different algorithms for determining atom identities +!* +!* A) Implementation of the CANGEN algorithm by Weininger et al. +!* D.Weininger et al., J. Chem. Inf. Comput. Sci., 1989, 29, 97-101. +!* doi.org/10.1021/ci00062a008 +!* The algorithm is used as the backend implementation to +!* determine the unqiue atom sequence in canonical SMILES. +!* It is pretty useful for all kinds of stuff, e.g. +!* for determining tautomers, or trying to restore atom order +!* +!* B) A custom implementation based on the all-pair-shortest-path +!* of the molecular graph, inspired by the Morgan algorithm +!* +!* C) a Helper algorithm to determine the (relative) stereo orientation +!* after a given canonical atom ranking has been generated +!************************************************************************* + use crest_parameters + use strucrd + use adjacency + use geo + implicit none + private + + public :: canonical_sorter + type :: canonical_sorter + !> system mapping + integer :: nat = 0 !> total number of atoms + integer :: hatms = 0 !> number of heavy atoms (>H) + integer :: nfrag = 0 !> number of molecules/subgraphs in structure + integer,allocatable :: nmap(:) !> map atom to heavy-atom list (H->0) + integer,allocatable :: hmap(:) !> map heavy-atom to full atom order + integer :: maxnei = 0 + integer,allocatable :: neigh(:,:) !> neighbour list (neigh(j,i) = j-th neighbour of atom i) + integer,allocatable :: hadjac(:,:) !> heavy-atom adjacency matrix + + !> the important bit for the algorithm + integer(int64),allocatable :: invariants(:) + integer,allocatable :: invariants0(:) + integer,allocatable :: prime(:) + integer,allocatable :: rank(:) !> That's what we are after + + !> workspace helpers + integer,allocatable :: newrank(:) + integer(int64),allocatable :: newinv(:) + + contains + procedure :: deallocate => deallocate_canonical_sorter + procedure :: shrink => shrink_canonical_sorter + procedure :: init => init_canonical_sorter + procedure :: update_ranks + procedure :: update_invariants + procedure :: iterate + procedure :: rankprint + procedure :: stereo => analyze_stereo + procedure :: compare => compare_canonical_sorter + end type canonical_sorter + + logical,parameter :: debug = .false. + +!========================================================================================! +!========================================================================================! +contains !> MODULE PROCEDURES START HERE +!========================================================================================! +!========================================================================================! + + subroutine deallocate_canonical_sorter(self) +!******************************************** +!* reset canonical_sorter entirely +!******************************************** + implicit none + class(canonical_sorter),intent(inout) :: self + self%nat = 0 + self%hatms = 0 + self%nfrag = 0 + if (allocated(self%nmap)) deallocate (self%nmap) + if (allocated(self%hmap)) deallocate (self%hmap) + if (allocated(self%invariants)) deallocate (self%invariants) + if (allocated(self%invariants0)) deallocate (self%invariants0) + if (allocated(self%rank)) deallocate (self%rank) + if (allocated(self%prime)) deallocate (self%prime) + if (allocated(self%hadjac)) deallocate (self%hadjac) + if (allocated(self%newrank)) deallocate (self%newrank) + if (allocated(self%newinv)) deallocate (self%newinv) + if (allocated(self%neigh)) deallocate (self%neigh) + end subroutine deallocate_canonical_sorter + +!========================================================================================! + + subroutine shrink_canonical_sorter(self) +!*************************************************************** +!* Reduce memory consumption of canconical_sorter +!* by deallocating everything except the (original) invariants +!* mappings and the determined ranks +!*************************************************************** + implicit none + class(canonical_sorter),intent(inout) :: self + if (allocated(self%invariants)) deallocate (self%invariants) + if (allocated(self%prime)) deallocate (self%prime) + if (allocated(self%hadjac)) deallocate (self%hadjac) + if (allocated(self%newrank)) deallocate (self%newrank) + if (allocated(self%newinv)) deallocate (self%newinv) + if (allocated(self%neigh)) deallocate (self%neigh) + end subroutine shrink_canonical_sorter + +!========================================================================================! + + subroutine init_canonical_sorter(self,mol,wbo,invtype) +!***************************************************************** +!* Initializes the canonical_sorter and runs the CANGEN algorithm +!***************************************************************** + implicit none + class(canonical_sorter),intent(inout) :: self + type(coord),intent(in) :: mol + real(wp),intent(in),optional :: wbo(mol%nat,mol%nat) + character(len=*),intent(in),optional :: invtype + integer :: nodes + integer,allocatable :: Amat(:,:) !> adjacency matrix for FULL molecule + integer :: counth,countb,countbo + real(wp) :: countbo2 + real(wp),allocatable :: cn(:),Bmat(:,:) + integer :: i,j,k,l,ii,ati,atj,maxnei + integer,allocatable :: ichrgs(:),frag(:) + character(len=:),allocatable :: myinvtype + logical :: use_icharges + +!>--- optional argument handling + if (present(invtype)) then + myinvtype = invtype + else + myinvtype = 'cangen' + end if + +!>--- all atoms of the full mol. graph are nodes + nodes = mol%nat + +!>--- map to heavy atom-only representation + k = 0 + do i = 1,mol%nat + if (mol%at(i) .ne. 1) k = k+1 + end do + self%nat = nodes + self%hatms = k + allocate (self%nmap(nodes)) + allocate (self%hmap(k)) + allocate (self%invariants(k),source=0_int64) + allocate (self%invariants0(k),source=0) + allocate (self%prime(k),source=2) + allocate (self%rank(k),source=1) + allocate (self%hadjac(k,k),source=0) + +!>--- determine number of subgraphs via CN + call mol%cn_to_bond(cn,Bmat,'cov') + call wbo2adjacency(nodes,Bmat,Amat,0.02_wp) + allocate (frag(nodes),source=0) + call setup_fragments(nodes,Amat,frag) + self%nfrag = maxval(frag(:),1) + deallocate (frag,cn,Bmat) + +!>--- get connectivity. Easiest is just via WBO (allocates Amat) +! call wbo2adjacency(nodes,wbo,Amat,0.02_wp) + +!>--- documment neighbour list + maxnei = 0 + do i = 1,mol%nat + k = count(Amat(:,i) > 0) + if (k > maxnei) maxnei = k + end do + if (debug) write (stdout,*) 'maximum number of neighbours',maxnei + self%maxnei = maxnei + allocate (self%neigh(maxnei,mol%nat),source=0) + +!>--- fill rest of self + k = 0 + do i = 1,nodes + l = 0 + if (mol%at(i) .ne. 1) then + k = k+1 + self%nmap(i) = k + self%hmap(k) = i + else + self%nmap(i) = 0 + end if + do j = 1,nodes + if (Amat(j,i) > 0) then + l = l+1 + self%neigh(l,i) = j + end if + end do + end do + do i = 1,k + do j = 1,i-1 + self%hadjac(j,i) = Amat(self%hmap(j),self%hmap(i)) + self%hadjac(i,j) = self%hadjac(j,i) + end do + end do + +!>--- get the first invatiants + if (allocated(mol%qat)) then + use_icharges = .true. + allocate (ichrgs(mol%nat),source=0) + ichrgs(:) = nint(mol%qat(:)) + else + use_icharges = .false. + end if + select case (myinvtype) + case ('apsp+') !> custom all-pair-shortest-path algo + + call get_invariant0_apsp(self%hatms,self%hadjac,self%invariants0) + do i = 1,k + ii = self%hmap(i) + ati = mol%at(ii) + counth = 0 + do j = 1,nodes + if (Amat(j,ii) .ne. 0) then + if (mol%at(j) .eq. 1) then + counth = counth+1 !> count H neighbours + end if + end if + end do + self%invariants0(i) = update_invariant0_apsp(self%invariants0(i),ati,counth) + end do + self%invariants(:) = real(self%invariants0(:)) + + case default !> CANGEN + + if(.not.present(wbo))then + error stop 'CANGEN implementation requires wbo matrix as argument' + endif + do i = 1,k + ii = self%hmap(i) + ati = mol%at(ii) + counth = 0 + countbo2 = 0.0_wp + countb = 0 + do j = 1,nodes + if (Amat(j,ii) .ne. 0) then + if (mol%at(j) .eq. 1) then + counth = counth+1 !> count H neighbours + countbo2 = countbo2-wbo(j,ii) !> but NOT in total bond order + end if + countb = countb+1 !> count all neighbours + !countbo2 = countbo2+wbo(j,ii) !> sum the total bond order + end if + countbo2 = countbo2+wbo(j,ii) !> sum the total bond order + end do + countb = countb-counth !> only heavy atom connections + !countbo = nint(countbo2)-counth !> same for number of bonds + countbo = nint(countbo2) + if (use_icharges) then + self%invariants(i) = get_invariant0(ati,countb,countbo,ichrgs(ii),counth) + else + self%invariants(i) = get_invariant0(ati,countb,countbo,0,counth) + end if + self%invariants0(i) = int(self%invariants(i)) !> back up for later tasks + end do + end select + + deallocate (Amat) + + if (debug) then + call debugprint(self,mol) + end if +!>--- start assignment + allocate (self%newrank(k),source=0) !> workspace + allocate (self%newinv(k),source=0_int64) !>workspace + call self%update_ranks() + self%rank(:) = self%newrank(:) + if (debug) then + call debugprint(self,mol) + end if + call self%update_invariants() + if (debug) then + call debugprint(self,mol) + end if + call self%iterate(mol) !> iterate recursively until ranking doesn't change + end subroutine init_canonical_sorter + +!========================================================================================! + + subroutine get_invariant0_apsp(hatms,hadjac,inv) + implicit none + integer,intent(in) :: hatms + integer,intent(in) :: hadjac(hatms,hatms) + integer,intent(out) :: inv(hatms) + + real(wp),allocatable :: dist(:,:) + real(wp),allocatable :: rinv(:),tmprinv(:) + integer,allocatable :: tmp(:,:) + integer :: i,j,k,l,maxdist,lpath + real(wp) :: maxrinv + inv(:) = 1 + + allocate (tmp(hatms,hatms),source=0) + allocate (dist(hatms,hatms),source=0.0_wp) + + !>--- calculate all-pair-shortest-path (APSP) + call FloydWarshall(hatms,hadjac,dist,tmp) + tmp(:,:) = nint(dist(:,:)) + maxdist = maxval(tmp) + do i = 1,hatms + tmp(i,i) = 0 + end do + deallocate (dist) + + !>--- get ranks using the APSP + allocate (rinv(hatms),tmprinv(hatms),source=1.0_wp) + do i = 1,maxdist + tmprinv(:) = 0 + do j = 1,hatms + do k = 1,hatms + if (tmp(k,j) .eq. i) then + tmprinv(j) = tmprinv(j)+rinv(k) + end if + end do + end do + rinv(:) = rinv(:)+tmprinv(:) + end do + + !>--- put the reversed order of rinv as "actual" invariant + k = 1 + do i = 1,hatms !> the out loop has the maximum possible number of iterations + maxrinv = maxval(rinv(:),1) + if (maxrinv < 0.0_wp) exit + do j = 1,hatms + if (rinv(j) >= maxrinv) then + inv(j) = k + rinv(j) = -1.0_wp + end if + end do + k = k+1 + end do + + deallocate (tmprinv,rinv) + deallocate (tmp) + end subroutine get_invariant0_apsp + function update_invariant0_apsp(inv_in,ati,hneigh) result(inv) +!************************************************************************ +!* update invariant for atom by appending atom type and number of H atoms +!************************************************************************* + implicit none + integer :: inv + integer,intent(in) :: inv_in !> previous invariant + integer,intent(in) :: ati !> atomic number + integer,intent(in) :: hneigh !> # H atoms bound to atom + inv = inv_in*10**3 + inv = inv+ati*10 + inv = inv+hneigh + end function update_invariant0_apsp + +!========================================================================================! + + function get_invariant0(ati,nneigh,nbonds,chrg,hneigh) result(inv) +!********************************************************************** +!* Get invariant for atom according to the origin al CANGEN scheme +!********************************************************************** + implicit none + integer :: inv + integer,intent(in) :: ati !> atomic number + integer,intent(in) :: nneigh !> # neighbours + integer,intent(in) :: nbonds !> # bonds (sum of wbo) + integer,intent(in) :: chrg !> charge on atom + integer,intent(in) :: hneigh !> # H atoms bound to atom + inv = 0 + inv = inv+nneigh*10**5 + inv = inv+nbonds*10**4 + inv = inv+ati*10**2 + inv = inv+chrg*10**1 + inv = inv+hneigh + end function get_invariant0 + +!=========================================================================================! + + subroutine update_ranks(self) +!>---update ranks and primes + implicit none + class(canonical_sorter) :: self + integer :: maxrank,i,j,k,ii + integer :: newrank,ngroup + integer(int64) :: mincurr + maxrank = maxval(self%rank,1) + newrank = 0 + !>-- use newinv as workingspace + self%newinv(:) = self%invariants(:) + RANKLOOP: do i = 1,maxrank + ngroup = count(self%rank(:) .eq. i) + if (debug) then + write (stdout,*) ngroup,' for rank ',i + end if + !>--- loop over all in the group + GROUPLOOP: do ii = 1,ngroup + mincurr = minval(self%newinv(:),self%rank(:) .eq. i) !> assign current minimum value within group + if (mincurr == huge(mincurr)) cycle RANKLOOP !> cycle if all in group have been assigned + newrank = newrank+1 + ASSIGNLOOP: do j = 1,self%hatms + if (self%rank(j) == i.and.self%newinv(j) == mincurr) then + self%newrank(j) = newrank + if (debug) then + write (stdout,*) 'new rank',newrank,'assigned to atom',j + end if + self%newinv(j) = huge(mincurr) !> remove this minimum value + end if + end do ASSIGNLOOP + end do GROUPLOOP + end do RANKLOOP +!>--- assign primes + do i = 1,self%hatms + !self%rank(i) = self%newrank(i) !> do this outside of routine + self%prime(i) = nth_prime(self%newrank(i)) + end do + end subroutine update_ranks + +!=========================================================================================! + + subroutine update_invariants(self) +!>---update invariants + implicit none + class(canonical_sorter) :: self + integer :: i,j,k,ii + integer(int64) :: invprod + do i = 1,self%hatms + invprod = 1 + !>--- loop over all heavy-atom neighbours of i + do j = 1,self%hatms + if (self%hadjac(j,i) > 0) then + invprod = invprod*self%prime(j) + end if + end do + self%newinv(i) = invprod + end do + if (debug) write (stdout,*) 'update invariants' + self%invariants(:) = self%newinv(:) + end subroutine update_invariants + +!========================================================================================! + + recursive subroutine iterate(self,mol) + implicit none + class(canonical_sorter) :: self + type(coord) :: mol + call self%update_ranks() + if (debug) then + call debugprint(self,mol) + end if + if (all(self%rank(:) .eq. self%newrank(:))) then + return !> termination condition + else + self%rank(:) = self%newrank(:) + end if + call self%update_invariants() + if (debug) then + call debugprint(self,mol) + end if + call self%iterate(mol) + end subroutine iterate + +!========================================================================================! + + subroutine analyze_stereo(self,mol) + implicit none + class(canonical_sorter) :: self + type(coord),intent(in) :: mol + integer :: i,ii,zero,nei,j,jj,maxrank + integer :: k,l,rs + integer,allocatable :: neiranks(:,:) + real(wp) :: coords(3,4) + logical,allocatable :: isstereo(:) + allocate (isstereo(mol%nat),source=.false.) + allocate (neiranks(4,mol%nat),source=0) + maxrank = maxval(self%rank(:)) + do i = 1,self%hatms + ii = self%hmap(i) + zero = count(self%neigh(:,ii) == 0) + nei = self%maxnei-zero +!>--- consider only atoms with 4 unique (in terms of CANGEN ranks) neighbours as stereocenter + if (nei == 4) then + do j = 1,4 + jj = self%neigh(j,ii) + if (mol%at(jj) == 1) then !> one hydrogen allowed + neiranks(j,ii) = maxrank+1 + else + neiranks(j,ii) = self%rank(jj) + end if + end do + !isstereo(ii) = unique_neighbours(nei,self%neigh(1:nei,ii)) + isstereo(ii) = unique_neighbours(4,neiranks(:,ii)) + end if + end do +!>--- do some actual geometry checks to determine "R" and "S" + do i = 1,mol%nat + if (isstereo(i)) then + !>--- transfer to dummy coords + do j = 1,4 + k = minloc(neiranks(:,i),1) + jj = self%neigh(k,i) + neiranks(k,i) = huge(k) + coords(1:3,j) = mol%xyz(1:3,jj)-mol%xyz(1:3,i) !> shift i to center of coordinates + end do + RS = determineRS(coords) + ii = self%nmap(i) + self%invariants0(ii) = (self%invariants0(ii)+abs(RS)*10**6)*RS + end if + end do + + if (debug) then + do ii = 1,self%hatms + self%invariants(ii) = self%invariants0(ii) + end do + call debugprint(self,mol) + end if + deallocate (neiranks,isstereo) + end subroutine analyze_stereo + +!========================================================================================! + + function compare_canonical_sorter(self,other) result(yesno) +!***************************************************** +!* compare two canonical_sorter objects to determine +!* if both correspond to the same molecule +!***************************************************** + implicit none + class(canonical_sorter) :: self + type(canonical_sorter) :: other + logical :: yesno + integer,allocatable :: sorted_invariants(:,:) + integer :: maxrank_a,maxrank_b,hatms + integer :: i,j,jj,k,kk + + yesno = .false. +!>--- the obvious cases first + if (self%nat .ne. other%nat) return + if (self%hatms .ne. other%hatms) return + maxrank_a = maxval(self%rank(:),1) + maxrank_b = maxval(other%rank(:),1) + if (maxrank_a .ne. maxrank_b) return + +!>--- if the easy checks passed, compare the actual invariants! + hatms = self%hatms + allocate (sorted_invariants(hatms,2),source=0) + jj = 0 + kk = 0 + do i = 1,maxrank_a !> maxrank_a == maxrank_b, see above + do j = 1,hatms + if (self%rank(j) == i) then + jj = jj+1 + sorted_invariants(jj,1) = self%invariants0(j) + end if + end do + do k = 1,hatms + if (other%rank(k) == i) then + kk = kk+1 + sorted_invariants(kk,2) = other%invariants0(k) + end if + end do + end do + + if (debug) then + do i = 1,hatms + write (stdout,'(i10,i10,i10)') i,sorted_invariants(i,:) + end do + end if + +!>--- assign identity + yesno = all(sorted_invariants(:,1) .eq. sorted_invariants(:,2)) + + deallocate (sorted_invariants) + return + end function compare_canonical_sorter + +!========================================================================================! +!========================================================================================! + + function nth_prime(x) result(prime) + implicit none + integer,intent(in) :: x + integer :: prime + integer :: c,num,i + logical :: is_prime + integer,parameter :: prime_numbers(100) = (/2,3,5,7,11,13,17,19,23,29, & + & 31,37,41,43,47,53,59,61,67,71,73,79,83,89,97,101,103,107,109, & + & 113,127,131,137,139,149,151,157,163,167,173,179,181,191,193,197, & + & 199,211,223,227,229,233,239,241,251,257,263,269,271,277,281,283, & + & 293,307,311,313,317,331,337,347,349,353,359,367,373,379,383,389, & + & 397,401,409,419,421,431,433,439,443,449,457,461,463,467,479,487, & + & 491,499,503,509,521,523,541/) + if (x <= 100) then + prime = prime_numbers(x) + return + end if + c = 0 + num = 1 + do while (c < x) + num = num+1 + is_prime = .true. + do i = 2,int(sqrt(real(num))) + if (mod(num,i) == 0) then + is_prime = .false. + exit + end if + end do + if (is_prime) then + c = c+1 + end if + end do + prime = num + end function nth_prime + +!========================================================================================! + + subroutine debugprint(can,mol) + implicit none + type(canonical_sorter) :: can + type(coord) :: mol + integer :: i,k,ii,ati + write (stdout,'(a10,a5,a15,a10,a10)') 'heavy-atom','type','invariant','rank','prime' + do i = 1,can%hatms + ii = can%hmap(i) + ati = mol%at(ii) + write (stdout,'(i10,a5,i15,i10,i10)') i,i2e(ati,'nc'),can%invariants(i),can%rank(i),can%prime(i) + end do + end subroutine debugprint + + subroutine rankprint(can,mol) + implicit none + class(canonical_sorter) :: can + type(coord) :: mol + integer :: i,k,ii,ati + write (stdout,'(a10,a10,a12,a10,2x,a)') 'heavy-atom','type','invariant0','rank','neighbours' + do i = 1,can%hatms + ii = can%hmap(i) + ati = mol%at(ii) + write (stdout,'(i10,a10,i12,i10,2x,a)') i,i2e(ati,'nc'),can%invariants0(i),can%rank(i),print_neighbours(mol,can%neigh(:,ii)) + end do + end subroutine rankprint + + function print_neighbours(mol,neigh) result(btmp) + implicit none + type(coord) :: mol + integer,intent(in) :: neigh(:) + character(len=:),allocatable :: btmp + character(len=20) :: atmp + integer :: i,j,k + btmp = '' + if (neigh(1) == 0) then + btmp = ' ---' + return + end if + do i = 1,size(neigh,1) + if (neigh(i) .ne. 0) then + write (atmp,'(a,a,a,i0,a)') ' ',trim(i2e(mol%at(neigh(i)))),'(',neigh(i),')' + btmp = trim(btmp)//trim(atmp) + end if + end do + end function print_neighbours + +!========================================================================================! + + function unique_neighbours(n,arr) result(yesno) + implicit none + integer,intent(in) :: n + integer,intent(in) :: arr(n) + logical :: yesno + integer :: i,j + yesno = .true. + do i = 1,n-1 + do j = i+1,n + if (arr(i) == arr(j)) then + yesno = .false. + exit + end if + end do + if (.not.yesno) exit + end do + end function unique_neighbours + +!========================================================================================! + + function determineRS(coords) result(RS) + implicit none + integer :: RS !> 1 for "R", -1 for "S" + real(wp),intent(inout) :: coords(3,4) + real(wp) :: theta + real(wp) :: vec(3),uec(3) + integer :: k,l,m,n + + k = 4 + !> rotate the highest prio atom onto z axis (0,0,1) + !> first into into xz plane, therefore get the -x unit vector first + !> and the projection of the neighbour in the xy-plane + vec = (/-1.0d0,0.0d0,0.0d0/) + uec(1) = coords(1,1) + uec(2) = coords(2,1) + uec(3) = 0.0_wp + theta = tangle(vec,uec) + !> then rotate around z-axis + vec = (/0.0d0,0.0d0,1.0d0/) + if (uec(2) .lt. 0.0_wp) theta = -theta + do l = 1,k + call rodrot(coords(:,l),vec,theta) + end do + + !> afterwards angle to the z-axis + vec = (/0.0d0,0.0d0,1.0d0/) + uec = coords(:,1) + theta = tangle(vec,uec) + !> then take this angle and rotate around y + vec = (/0.0d0,1.0d0,0.0d0/) + do l = 1,k + call rodrot(coords(:,l),vec,theta) + end do + + !> as a last step tak the lowest-prio neighbour and rotate it into the xy-plane + vec = (/-1.0d0,0.0d0,0.0d0/) + uec(1) = coords(1,k) + uec(2) = coords(2,k) + uec(3) = 0.0_wp + theta = tangle(vec,uec) + vec = (/0.0,0.0,1.0/) + if (uec(2) .lt. 0.0_wp) theta = -theta + do l = 1,k + call rodrot(coords(:,l),vec,theta) + end do + + !determine orientation + if (coords(2,2) .gt. coords(2,3)) then + RS = 1 + else + RS = -1 + end if + + end function determineRS + +!========================================================================================! +!========================================================================================! +end module canonical_mod diff --git a/src/classes.f90 b/src/classes.f90 index 7014d469..1f7ce783 100644 --- a/src/classes.f90 +++ b/src/classes.f90 @@ -72,6 +72,8 @@ module crest_data integer,parameter,public :: crest_pka = 14 integer,parameter,public :: crest_solv = 15 integer,parameter,public :: crest_protonate = 16 + integer,parameter,public :: crest_deprotonate = 17 + integer,parameter,public :: crest_tautomerize = 18 !>> runtypes with IDs between use non-legacy routines < separate EWIN threshold integer :: swchrg = 1 !> switch element charge integer :: swat = 1 !> switch element element + integer :: amount = 1 !> how many protons to add? logical :: swelem = .false. !> switch element to add to lmo lp pair? logical :: allowFrag = .false. !> allow fragmentation logical :: threshsort = .false. !> use ewin threshold diff --git a/src/cleanup.f90 b/src/cleanup.f90 index d9071e0e..c3f43f06 100644 --- a/src/cleanup.f90 +++ b/src/cleanup.f90 @@ -71,9 +71,11 @@ subroutine custom_cleanup(env) call rmrfw('.cre_') call rmrf('cregen_*.tmp') call rmrf('MDFILES') + if(allocated(env%calc%calcs))then if(.not.any(env%calc%calcs(:)%pr))then call rmrfw('calculation.level.') endif + endif endif call rmrf('.CHRG .UHF') call rmrf('.history.xyz') diff --git a/src/cn.f90 b/src/cn.f90 index 368a9223..b47ba3bb 100644 --- a/src/cn.f90 +++ b/src/cn.f90 @@ -51,7 +51,7 @@ module crest_cn_module !========================================================================================! !========================================================================================! - subroutine calculate_CN(nat,at,xyz,cn,cnthr,cntype,dcndr) + subroutine calculate_CN(nat,at,xyz,cn,cnthr,cntype,dcndr,bond) !********************************************************* !* Universal CN calculator with several optional settings !* for customisation. @@ -63,6 +63,7 @@ subroutine calculate_CN(nat,at,xyz,cn,cnthr,cntype,dcndr) !* cnthr - pair distance cutoff in Bohr !* cntype - string to select CN type (exp,erf,erf_en) !* dcndr - optional output cn derivatives +!* bond - optional output "bond" connectivity matrix !********************************************************* implicit none !> INPUT @@ -75,13 +76,14 @@ subroutine calculate_CN(nat,at,xyz,cn,cnthr,cntype,dcndr) real(wp),intent(in),optional :: cnthr character(len=*),intent(in),optional :: cntype real(wp),intent(out),optional :: dcndr(:,:,:) + real(wp),intent(out),allocatable,optional :: bond(:,:) !> LOCAL real(wp) :: cn_thr,cn_direct integer :: cn_type,ati,atj real(wp) :: rcovi,rcovj,rij(3),r2,r,rco real(wp) :: damp,ddamp(3),den integer :: i,j,k,l,iat,jat - logical :: deriv + logical :: deriv,getbond !>--- check options and defaults if (present(cnthr)) then @@ -118,6 +120,14 @@ subroutine calculate_CN(nat,at,xyz,cn,cnthr,cntype,dcndr) deriv = .false. end if + if(present(bond))then + getbond=.true. + allocate(bond(nat,nat),source=0.0_wp) + else + getbond=.false. + endif + + cn(:) = 0.0_wp !>--- actual calculation @@ -155,6 +165,11 @@ subroutine calculate_CN(nat,at,xyz,cn,cnthr,cntype,dcndr) damp = cn_damp_gfn(rco,r) if (deriv) ddamp(:) = dcn_damp_gfn(rco,r)*(rij(:)/r) end select + + if(getbond)then + bond(j,i) = damp + bond(i,j) = damp + endif cn(i) = cn(i)+damp if (i /= j) then diff --git a/src/confparse.f90 b/src/confparse.f90 index 74a60a3b..1742bc71 100644 --- a/src/confparse.f90 +++ b/src/confparse.f90 @@ -461,16 +461,21 @@ subroutine parseflags(env,arg,nra) case ('-protonate') !> protonation tool env%properties = p_protonate env%crestver = crest_protonate + env%legacy = .true. !> TODO, set active at later version write (*,'(2x,a,'' : automated protonation script'')') trim(arg(i)) exit case ('-deprotonate') !> deprotonation tool env%properties = p_deprotonate + env%crestver = crest_deprotonate + env%legacy = .true. !> TODO, set active at later version write (*,'(2x,a,'' : automated deprotonation script'')') trim(arg(i)) exit case ('-tautomerize') !> tautomerization tool env%properties = p_tautomerize + env%crestver = crest_tautomerize + env%legacy = .true. !> TODO, set active at later version write (*,'(2x,a,'' : automated tautomerization script'')') trim(arg(i)) exit @@ -538,6 +543,7 @@ subroutine parseflags(env,arg,nra) env%doOHflip = .false. !> Switch off OH-flip if (env%iterativeV2) env%iterativeV2 = .false. exit + env%legacy = .true. !> force legacy routines for now case ('-compress') env%crestver = crest_compr @@ -1078,6 +1084,8 @@ subroutine parseflags(env,arg,nra) case ('-cross') env%performCross = .true. !> do the genetic crossing env%autozsort = .true. + case ('-keepdir','-keeptmp') !> Do not delete temporary directories at the end + env%keepModef = .true. case ('-opt','-optlev') !> settings for optimization level of GFN-xTB env%optlev = optlevnum(arg(i+1)) write (*,'(2x,a,1x,a)') trim(arg(i)),optlevflag(env%optlev) @@ -1582,6 +1590,11 @@ subroutine parseflags(env,arg,nra) env%properties = p_protonate env%autozsort = .false. env%protb%threshsort = .true. + ctmp = trim(arg(i+1)) + if (ctmp(1:1) .ne. '-') then + read(ctmp,*,iostat=io) idum + if(io.eq.0) env%protb%amount = idum + end if case ('-swel') !> switch out H+ to something else in protonation script if (env%properties .eq. -3) then call swparse(arg(i+1),env%protb) @@ -1590,6 +1603,11 @@ subroutine parseflags(env,arg,nra) env%properties = p_deprotonate env%autozsort = .false. env%protb%threshsort = .true. + ctmp = trim(arg(i+1)) + if (ctmp(1:1) .ne. '-') then + read(ctmp,*,iostat=io) idum + if(io.eq.0) env%protb%amount = idum + end if case ('-tautomerize') !> tautomerization tool env%properties = p_tautomerize env%autozsort = .false. diff --git a/src/cregen.f90 b/src/cregen.f90 index 905cfb1c..31b86ca9 100644 --- a/src/cregen.f90 +++ b/src/cregen.f90 @@ -105,7 +105,7 @@ subroutine newcregen(env,quickset,infile) logical :: conffile logical :: bonusfiles logical :: anal - logical :: saveelow = .true. + logical :: saveelow logical :: userinput !>--- printout directions @@ -139,7 +139,7 @@ subroutine newcregen(env,quickset,infile) !>-- determine which subroutines are required call cregen_director(env,simpleset,checkbroken,sortE,sortRMSD,sortRMSD2, & - & repairord,newfile,conffile,bonusfiles,anal,topocheck,checkez) + & repairord,newfile,conffile,bonusfiles,anal,topocheck,checkez,saveelow) !>--- DATA SECTION call cregen_filldata1(env,ewin,rthr,ethr,bthr,athr,pthr,T,couthr) @@ -444,7 +444,7 @@ end subroutine cregen_prout !=========================================================================================! subroutine cregen_director(env,simpleset,checkbroken,sortE,sortRMSD,sortRMSD2, & - & repairord,newfile,conffile,bonusfiles,anal,topocheck,checkez) + & repairord,newfile,conffile,bonusfiles,anal,topocheck,checkez,saveelow) !************************************************************** !* subroutine cregen_director !IMPORTANT! !* handle which comparisons are required and which files shall @@ -464,6 +464,7 @@ subroutine cregen_director(env,simpleset,checkbroken,sortE,sortRMSD,sortRMSD2, & logical,intent(out) :: anal logical,intent(out) :: topocheck logical,intent(out) :: checkez + logical,intent(out) :: saveelow checkbroken = .true. !> fragmentized structures are sorted out sortE = .true. !> sort based on energy @@ -475,6 +476,8 @@ subroutine cregen_director(env,simpleset,checkbroken,sortE,sortRMSD,sortRMSD2, & conffile = .true. !> sorted unique structure file + saveelow = .true. !> save (overwrite) lowest structure to env%ref + topocheck = env%checktopo !> topology is compared to reference structure checkez = env%checkiso !> check for C=C cis/trans isomerizations if (env%relax) then @@ -509,6 +512,7 @@ subroutine cregen_director(env,simpleset,checkbroken,sortE,sortRMSD,sortRMSD2, & checkez = .false. bonusfiles = .false. anal = .false. + saveelow = .false. end if if (simpleset == 9) then !optpurge mode diff --git a/src/crest_main.f90 b/src/crest_main.f90 index f8da3347..c8d9fc41 100644 --- a/src/crest_main.f90 +++ b/src/crest_main.f90 @@ -145,13 +145,13 @@ program CREST ! call protonate(env,tim) ! call propquit(tim) !>--- deprotonation - case (p_deprotonate) - call deprotonate(env,tim) - call propquit(tim) +! case (p_deprotonate) +! call deprotonate(env,tim) +! call propquit(tim) !>--- tautomerization - case (p_tautomerize) - call tautomerize(env,tim) - call propquit(tim) +! case (p_tautomerize) +! call tautomerize(env,tim) +! call propquit(tim) !>--- extended tautomerization case (p_tautomerize2) call tautomerize_ext(env%ensemblename,env,tim) @@ -292,6 +292,12 @@ program CREST case(crest_protonate) call protonate(env,tim) + + case(crest_deprotonate) + call deprotonate(env,tim) + + case(crest_tautomerize) + call tautomerize(env,tim) case (crest_test) call crest_playground(env,tim) diff --git a/src/legacy_algos/deprotonate.f90 b/src/legacy_algos/deprotonate.f90 index 47d699bd..3a03b0bd 100644 --- a/src/legacy_algos/deprotonate.f90 +++ b/src/legacy_algos/deprotonate.f90 @@ -37,7 +37,7 @@ end subroutine deprothead !-------------------------------------------------------------------------------------------- ! Protonation workflow with GFNn-xTB !-------------------------------------------------------------------------------------------- -subroutine deprotonate(env,tim) +subroutine deprotonate_legacy(env,tim) use crest_parameters use crest_data use iomod @@ -185,7 +185,7 @@ subroutine deprotonate(env,tim) !call chdir(thispath) return -end subroutine deprotonate +end subroutine deprotonate_legacy !----------------------------------------------------! ! for every structure calculate an correction diff --git a/src/legacy_algos/tautomerize.f90 b/src/legacy_algos/tautomerize.f90 index a764794e..0dc986f2 100644 --- a/src/legacy_algos/tautomerize.f90 +++ b/src/legacy_algos/tautomerize.f90 @@ -35,7 +35,7 @@ end subroutine tauthead !-------------------------------------------------------------------------------------------- ! Tautomerization workflow with GFNn-xTB !-------------------------------------------------------------------------------------------- -subroutine tautomerize(env,tim) +subroutine tautomerize_legacy(env,tim) use crest_parameters use crest_data use iomod @@ -196,7 +196,7 @@ subroutine tautomerize(env,tim) call new_wrsdfens(env,'tautomers.xyz','tautomers.sdf',.true.) end if -end subroutine tautomerize +end subroutine tautomerize_legacy !-------------------------------------------------------------------------------------------- ! small verion of the protonate routine diff --git a/src/legacy_wrappers.f90 b/src/legacy_wrappers.f90 index daf9a909..cc4d7e3f 100644 --- a/src/legacy_wrappers.f90 +++ b/src/legacy_wrappers.f90 @@ -361,13 +361,52 @@ subroutine protonate(env,tim) implicit none type(systemdata) :: env type(timer) :: tim -! if (env%legacy) then + if (env%legacy) then call protonate_legacy(env,tim) -! else -! call crest_new_protonate(env,tim) -! end if + else + call crest_new_protonate(env,tim) + end if end subroutine protonate +!================================================================================! + +subroutine deprotonate(env,tim) +!***************************************************** +!* subroutine deprotonate +!* driver for the automated deprotonation site search +!***************************************************** + use iso_fortran_env,only:wp => real64 + use crest_data + implicit none + type(systemdata) :: env + type(timer) :: tim + if (env%legacy) then + call deprotonate_legacy(env,tim) + else + call crest_new_deprotonate(env,tim) + end if +end subroutine deprotonate + +!================================================================================! + +subroutine tautomerize(env,tim) +!***************************************************** +!* subroutine tautomerize +!* driver for the automated tautomer search +!***************************************************** + use iso_fortran_env,only:wp => real64 + use crest_data + implicit none + type(systemdata) :: env + type(timer) :: tim + if (env%legacy) then + call tautomerize_legacy(env,tim) + else + call crest_new_tautomerize(env,tim) + end if +end subroutine tautomerize + + !========================================================================================! subroutine catchdiatomic(env) diff --git a/src/meson.build b/src/meson.build index 09929f54..1fd7359b 100644 --- a/src/meson.build +++ b/src/meson.build @@ -34,6 +34,7 @@ srcs += files( 'axis_module.f90', 'biasmerge.f90', 'bondconstraint.f90', + 'canonical.f90', 'ccegen.f90', 'choose_settings.f90', 'classes.f90', @@ -76,7 +77,6 @@ srcs += files( 'strucreader.f90', 'symmetry2.f90', 'symmetry_i.c', - 'testmol.f90', 'timer.f90', 'trackorigin.f90', 'utilmod.f90', diff --git a/src/ompmklset.F90 b/src/ompmklset.F90 index 5071311b..6365cc38 100644 --- a/src/ompmklset.F90 +++ b/src/ompmklset.F90 @@ -29,9 +29,20 @@ subroutine ompmklset(threads) call OMP_Set_Num_Threads(threads) #ifdef WITH_MKL call MKL_Set_Num_Threads(threads) + call mkl_set_dynamic(0) #endif +! call openblasset(threads) end subroutine ompmklset +subroutine openblasset(threads) + implicit none + integer,intent(in) :: threads +#ifdef WITH_OPENBLAS + call openblas_set_num_threads(threads) +#endif + return +end subroutine openblasset + !ccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccc! !c OMP and MKL parallelization settings (short routine) !ccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccc! @@ -44,6 +55,7 @@ subroutine ompenvset(omp) io = setenv('OMP_NUM_THREADS',omp) io = setenv('MKL_NUM_THREADS',omp) + io = setenv('OPENBLAS_NUM_THREADS',omp) end subroutine ompenvset @@ -66,11 +78,10 @@ subroutine new_ompautoset(env,modus,maxjobs,parallel_jobs,cores_per_job) !> The default, all threads allocated to CREST T = env%threads - parallel_jobs = T + parallel_jobs = max(1,T) cores_per_job = 1 !> More settings, nested parallelization reset call omp_set_max_active_levels(1) - !call omp_set_dynamic(.true.) select case (modus) case ('auto','auto_nested') @@ -87,8 +98,14 @@ subroutine new_ompautoset(env,modus,maxjobs,parallel_jobs,cores_per_job) if (env%omp_allow_nested) then !> We should never need more than two active nested layers call omp_set_max_active_levels(2) - end if + endif + else +#ifdef WITH_MKL + !call mkl_free_buffers() + call mkl_set_dynamic(0) +#endif end if + call openblasset(1) case ('max') !> Both intern and environment variable threads to max @@ -100,18 +117,30 @@ subroutine new_ompautoset(env,modus,maxjobs,parallel_jobs,cores_per_job) parallel_jobs = 1 cores_per_job = 1 - case ('subprocess') + case ('subprocess','la-focus') !> CREST itself uses one thread, and but the environment variable is set to max !> which is useful when driving a single subprocess/systemcall parallel_jobs = 1 - cores_per_job = T + cores_per_job = T + + !> the setting may also be used for linear-algebra focused runs, in which case + !> nested parallelism should be active + if (env%omp_allow_nested) then + !> We should never need more than two active nested layers + call omp_set_max_active_levels(2) + endif end select !> apply the calculated settings call ompmklset(parallel_jobs) call ompenvset(cores_per_job) - +#ifdef WITH_OPENBLAS +! if(modus.ne.'auto'.and.modus.ne.'auto_nested')then +! call openblasset(cores_per_job) +! endif + call openblasset(1) +#endif end subroutine new_ompautoset !ccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccc! diff --git a/src/optimize/optutils.f90 b/src/optimize/optutils.f90 index 6be6fd2e..ee943152 100644 --- a/src/optimize/optutils.f90 +++ b/src/optimize/optutils.f90 @@ -29,7 +29,6 @@ module optimize_utils use axis_module use strucrd use ls_rmsd - use testmol use optimize_type use optimize_maths diff --git a/src/printouts.f90 b/src/printouts.f90 index 7fce00bf..30980623 100644 --- a/src/printouts.f90 +++ b/src/printouts.f90 @@ -99,7 +99,11 @@ subroutine box3(version,date,commit,author) write (*,'(a,a)') repeat(" ",pad_left),trim(logo(i)) end do write (*,'(a,''Version '',a,'', '',a)') repeat(" ",pad_left),trim(version),trim(date) + if(author(1:1).eq.'@')then + write (*,'(a,"commit (",a,") compiled by ",a)') repeat(" ",pad_left),commit,'usr'//author + else write (*,'(a,"commit (",a,") compiled by ",a)') repeat(" ",pad_left),commit,author + endif end subroutine box3 subroutine disclaimer @@ -719,7 +723,11 @@ subroutine print_crest_metadata() write (*,'(2x,a,1x,a)') 'CREST version :',version write (*,'(2x,a,1x,a)') 'timestamp :',date write (*,'(2x,a,1x,a)') 'commit :',commit + if(author(1:1).eq.'@')then + write (*,'(2x,a,1x,a)') 'compiled by :','usr'//author + else write (*,'(2x,a,1x,a)') 'compiled by :',author + endif write (*,'(2x,a,1x,a)') 'Fortran compiler :',fcompiler write (*,'(2x,a,1x,a)') 'C compiler :',ccompiler write (*,'(2x,a,1x,a)') 'build system :',bsystem diff --git a/src/strucreader.f90 b/src/strucreader.f90 index 12ef7534..24c7e583 100644 --- a/src/strucreader.f90 +++ b/src/strucreader.f90 @@ -41,7 +41,7 @@ module strucrd use geo !> element symbols use miscdata,only:PSE - use crest_cn_module, only: calculate_cn + use crest_cn_module,only:calculate_cn implicit none !=========================================================================================! @@ -193,6 +193,9 @@ module strucrd !>-- lattice vectors real(wp),allocatable :: lat(:,:) + !>-- atomic charges + real(wp),allocatable :: qat(:) + !>-- (optional) PDB data type(pdbdata) :: pdb @@ -206,9 +209,10 @@ module strucrd procedure :: dist => coord_getdistance !> calculate distance between two atoms procedure :: angle => coord_getangle !> calculate angle between three atoms procedure :: dihedral => coord_getdihedral !> calculate dihedral angle between four atoms - procedure :: cutout => coord_getcutout !> create a substructure + procedure :: cutout => coord_getcutout !> create a substructure procedure :: get_CN => coord_get_CN !> calculate coordination number procedure :: get_z => coord_get_z !> calculate nuclear charge + procedure :: cn_to_bond => coord_cn_to_bond !> generate neighbour matrix from CN end type coord !=========================================================================================! !ensemble class. contains all structures of an ensemble @@ -563,27 +567,27 @@ subroutine rdensemble_coord_type(fname,nall,structures) call rdensembleparam(fname,nat,nall,multiple_sizes) !>--- multiple sizes - allocate(structures(nall)) - allocate(xyz(3,nat,nall),ats(nat,nall),nats(nall),eread(nall)) - allocate(comments(nall)) - call rdensemble_mixed2(fname,nat,nall,nats,ats,xyz,comments) - !>>>>>>>>>>>>>>>>>>>>>><<<<<<<<<<<<<<<<<<<<<<--- Important: coord types must be in Bohrs - xyz = xyz/bohr - !>>>>>>>>>>>>>>>>>>>>>><<<<<<<<<<<<<<<<<<<<<<>>>>>>>>>>>>>>>>>>>>><<<<<<<<<<<<<<<<<<<<<<--- Important: coord types must be in Bohrs + xyz = xyz/bohr + !>>>>>>>>>>>>>>>>>>>>>><<<<<<<<<<<<<<<<<<<<<< 57 .and. self%at(i) < 72) z(i) = 3.0_wp - enddo + if (self%nat <= 0) return + if (.not.allocated(self%xyz).or..not.allocated(self%at)) return + allocate (z(self%nat),source=0.0_wp) + do i = 1,self%nat + z(i) = real(self%at(i),wp)-real(ncore(self%at(i))) + if (self%at(i) > 57.and.self%at(i) < 72) z(i) = 3.0_wp + end do end subroutine coord_get_z +!==================================================================! + + subroutine coord_cn_to_bond(self,cn,bond,cn_type,cn_thr) + implicit none + class(coord) :: self + real(wp),intent(out),allocatable :: cn(:) + real(wp),intent(out),allocatable,optional :: bond(:,:) + real(wp),intent(in),optional :: cn_thr + character(len=*),intent(in),optional :: cn_type + if (self%nat <= 0) return + if (.not.allocated(self%xyz).or..not.allocated(self%at)) return + allocate (cn(self%nat),source=0.0_wp) + call calculate_CN(self%nat,self%at,self%xyz,cn, & + & cntype=cn_type,cnthr=cn_thr,bond=bond) + end subroutine coord_cn_to_bond + + !=========================================================================================! !=========================================================================================! ! 3. ROUTINES FOR WRITING STRUCTURES AND CONVERTING THEM @@ -2070,30 +2088,30 @@ function convertlable(s) end function convertlable !=============================================================! -pure elemental integer function ncore(at) - integer,intent(in) :: at - if(at.le.2)then - ncore=0 - elseif(at.le.10)then - ncore=2 - elseif(at.le.18)then - ncore=10 - elseif(at.le.29)then !zn - ncore=18 - elseif(at.le.36)then - ncore=28 - elseif(at.le.47)then - ncore=36 - elseif(at.le.54)then - ncore=46 - elseif(at.le.71)then - ncore=54 - elseif(at.le.79)then - ncore=68 - elseif(at.le.86)then - ncore=78 - endif -end function ncore + pure elemental integer function ncore(at) + integer,intent(in) :: at + if (at .le. 2) then + ncore = 0 + elseif (at .le. 10) then + ncore = 2 + elseif (at .le. 18) then + ncore = 10 + elseif (at .le. 29) then !zn + ncore = 18 + elseif (at .le. 36) then + ncore = 28 + elseif (at .le. 47) then + ncore = 36 + elseif (at .le. 54) then + ncore = 46 + elseif (at .le. 71) then + ncore = 54 + elseif (at .le. 79) then + ncore = 68 + elseif (at .le. 86) then + ncore = 78 + end if + end function ncore !============================================================! ! e2i is used to map the element (as a string) to integer @@ -2221,9 +2239,9 @@ function grepenergy(line) k=index(atmp,'energy:') atmp=atmp(k+7:) read (atmp,*,iostat=io) energy - if(io.ne.0) energy=0.0_wp - else - !> assumes that the first float in the line is the energy + if (io .ne. 0) energy = 0.0_wp + else + !> assumes that the first float in the line is the energy do i = 1,len_trim(atmp) if (len_trim(atmp) .lt. 1) exit read (atmp,*,iostat=io) energy @@ -2235,7 +2253,7 @@ function grepenergy(line) exit end if end do - endif + end if grepenergy = energy return end function grepenergy @@ -2306,24 +2324,24 @@ subroutine get_atlist(nat,atlist,line,at) !>--- analyze stuff do i = 1,ns atmp = trim(substr(i)) - if(atmp.eq.'all')then - atlist(:) = .true. - exit - endif - if(index(atmp,'.').ne.0) cycle !> exclude floats + if (atmp .eq. 'all') then + atlist(:) = .true. + exit + end if + if (index(atmp,'.') .ne. 0) cycle !> exclude floats l = index(atmp,'-') if (l .eq. 0) then read (atmp,*,iostat=io) i1 !> check if it is an element symbol if (io /= 0) then - if(len_trim(atmp) > 2)then - if(index(trim(atmp),'heavy').ne.0)then !> all heavy atoms + if (len_trim(atmp) > 2) then + if (index(trim(atmp),'heavy') .ne. 0) then !> all heavy atoms if (present(at)) then - do j = 1,nat - if (at(j) > 1) atlist(j) = .true. - end do + do j = 1,nat + if (at(j) > 1) atlist(j) = .true. + end do end if - endif + end if else !> element symbols k = e2i(atmp) if (present(at)) then @@ -2331,7 +2349,7 @@ subroutine get_atlist(nat,atlist,line,at) if (at(j) == k) atlist(j) = .true. end do end if - endif + end if else atlist(i1) = .true. end if @@ -2349,7 +2367,7 @@ subroutine get_atlist(nat,atlist,line,at) end if end if end do - deallocate(substr) + deallocate (substr) end subroutine get_atlist !=========================================================================================! diff --git a/src/testmol.f90 b/src/testmol.f90 deleted file mode 100644 index 0a55e095..00000000 --- a/src/testmol.f90 +++ /dev/null @@ -1,38 +0,0 @@ -module testmol - use iso_fortran_env,only:wp => real64 - - integer,parameter :: testnat = 24 - integer,parameter :: testat(testnat) = [6,7,6,7,6,6,6,8,7,6,8,7,6,6, & - & 1,1,1,1,1,1,1,1,1,1] - real(wp),parameter :: testxyz(3,testnat) = reshape(& - &[2.02799738646442_wp,0.09231312124713_wp,-0.14310895950963_wp, & - & 4.75011007621000_wp,0.02373496014051_wp,-0.14324124033844_wp, & - & 6.33434307654413_wp,2.07098865582721_wp,-0.14235306905930_wp, & - & 8.72860718071825_wp,1.38002919517619_wp,-0.14265542523943_wp, & - & 8.65318821103610_wp,-1.19324866489847_wp,-0.14231527453678_wp, & - & 6.23857175648671_wp,-2.08353643730276_wp,-0.14218299370797_wp, & - & 5.63266886875962_wp,-4.69950321056008_wp,-0.13940509630299_wp, & - & 3.44931709749015_wp,-5.48092386085491_wp,-0.14318454855466_wp, & - & 7.77508917214346_wp,-6.24427872938674_wp,-0.13107140408805_wp, & - & 10.30229550927022_wp,-5.39739796609292_wp,-0.13672168520430_wp, & - & 12.07410272485492_wp,-6.91573621641911_wp,-0.13666499342053_wp, & - & 10.70038521493902_wp,-2.79078533715849_wp,-0.14148379504141_wp, & - & 13.24597858727017_wp,-1.76969072232377_wp,-0.14218299370797_wp, & - & 7.40891694074004_wp,-8.95905928176407_wp,-0.11636933482904_wp, & - & 1.38702118184179_wp,2.05575746325296_wp,-0.14178615122154_wp, & - & 1.34622199478497_wp,-0.86356704498496_wp,1.55590600570783_wp, & - & 1.34624089204623_wp,-0.86133716815647_wp,-1.84340893849267_wp, & - & 5.65596919189118_wp,4.00172183859480_wp,-0.14131371969009_wp, & - & 14.67430918222276_wp,-3.26230980007732_wp,-0.14344911021228_wp, & - & 13.50897177220290_wp,-0.60815166181684_wp,1.54898960808727_wp, & - & 13.50780014200488_wp,-0.60614855212345_wp,-1.83214617078268_wp, & - & 5.41408424778406_wp,-9.49239668625902_wp,-0.11022772492007_wp, & - & 8.31919801555568_wp,-9.74947502841788_wp,1.56539243085954_wp, & - & 8.31511620712388_wp,-9.76854236502758_wp,-1.79108242206824_wp], & - & shape(testxyz)) - - public :: testnat - public :: testat - public :: testxyz - -end module testmol diff --git a/src/utilmod.f90 b/src/utilmod.f90 index 73836b0b..5ba52271 100644 --- a/src/utilmod.f90 +++ b/src/utilmod.f90 @@ -38,6 +38,7 @@ module utilities public :: TRJappendto_skipfirst public :: XYZappendto public :: dumpenergies + public :: get_combinations !> functions public :: lin @@ -46,6 +47,8 @@ module utilities public :: ohbonded2 public :: ohbonded public :: distcma + public :: binomial + public :: factorial !========================================================================================! !========================================================================================! @@ -539,6 +542,67 @@ subroutine dumpenergies(filename,eread) close (ich) end subroutine dumpenergies +!========================================================================================! + + function binomial(n, k) result(res) +!************************************************** +!* Function to calculate the binomial coefficient +!* +!* ⎛ n ⎞ +!* ⎝ k ⎠ = n! / (k! * (n - k)!) +!* +!************************************************** + implicit none + integer, intent(in) :: n, k + real(wp) :: reswp + integer :: res + reswp = factorial(n) / (factorial(k) * factorial(n - k)) + res = nint(reswp) + end function binomial + + + function factorial(x) result(fact) +!*************************************************** +!* Function to calculate the factorial of a number +!* factorial(x) = x! = x * (x-1) * (x-2) * ... * 1 +!*************************************************** + implicit none + integer, intent(in) :: x + integer :: i + real(wp) :: fact + fact = 1.0_wp + do i = 2, x + fact = fact * real(i,wp) + end do + end function factorial + + + recursive subroutine get_combinations(n, k, ntot, c, combinations, tmp, depth) + implicit none + integer, intent(in) :: n, k, ntot, depth !> depth should start out as 0 + integer,intent(inout) :: c,tmp(k) + integer, intent(inout) :: combinations(k,ntot) + integer :: i + if (depth >= k) then + c=c+1 + combinations(:,c) = tmp(:) + return + else if(depth==0)then + do i=1,n + tmp(depth+1) = i + call get_combinations(n, k, ntot, c, combinations, tmp, depth+1) + enddo + else + do i=1,tmp(depth) + if(i==tmp(depth)) cycle + tmp(depth+1) = i + call get_combinations(n, k, ntot, c, combinations, tmp, depth+1) + enddo + end if + end subroutine get_combinations + + + !========================================================================================! !========================================================================================! end module utilities diff --git a/subprojects/tblite b/subprojects/tblite index 1665c595..4556e28f 160000 --- a/subprojects/tblite +++ b/subprojects/tblite @@ -1 +1 @@ -Subproject commit 1665c5959a588a3b2388b420baca6e9198773cbd +Subproject commit 4556e28f391573b3c80c94beb7c56313005d5269 diff --git a/subprojects/tblite.wrap b/subprojects/tblite.wrap index 261920a9..bb401a77 100644 --- a/subprojects/tblite.wrap +++ b/subprojects/tblite.wrap @@ -1,4 +1,4 @@ [wrap-git] directory = tblite -url = https://github.com/tblite/tblite -revision = main +url = https://github.com/ppracht/tblite +revision = xtb_solvation diff --git a/test/CMakeLists.txt b/test/CMakeLists.txt index 4b06e776..f1e0acc6 100644 --- a/test/CMakeLists.txt +++ b/test/CMakeLists.txt @@ -11,6 +11,7 @@ set( set( test-srcs "testmol.f90" + "helpers.f90" "main.f90" ) foreach(t IN LISTS tests) diff --git a/test/helpers.f90 b/test/helpers.f90 new file mode 100644 index 00000000..dbaa4b8a --- /dev/null +++ b/test/helpers.f90 @@ -0,0 +1,87 @@ +module test_helpers + use testdrive,only:error_type,check,test_failed + use crest_parameters + use crest_testmol + use crest_calculator + use strucrd + implicit none + private + + public :: test_e,test_g + +!========================================================================================! +!========================================================================================! +contains !> Helper routines for testing +!========================================================================================! +!========================================================================================! + + subroutine test_e(mol,calc,error,ref) +!*********************************************** +!* calculate energy and cross-check with +!* a given reference +!*********************************************** + !> Error handling + type(error_type),allocatable,intent(out) :: error + !> calculation data + type(calcdata),intent(inout) :: calc + !> molecule + type(coord),intent(inout) :: mol + !> reference energy + real(wp),intent(in) :: ref + !> LOCAL + real(wp),parameter :: thr = sqrt(epsilon(1.0_wp)) + real(wp),allocatable :: gradient(:,:) + integer :: io + real(wp) :: energy + + energy=0.0_wp + + !> calculation + allocate (gradient(3,mol%nat),source=0.0_wp) + call engrad(mol,calc,energy,gradient,io) + + if (abs(energy-ref) > thr) then + !call test_failed(error,"energy does not match reference") + call calc%info(stdout) + call check(error,energy,ref,thr=thr) + end if + + end subroutine test_e + + subroutine test_g(mol,calc,error) +!*********************************************** +!* calculate numerical gradient and cross-check +!* with the one returned by calculator +!*********************************************** + !> Error handling + type(error_type),allocatable,intent(out) :: error + !> calculation data + type(calcdata),intent(inout) :: calc + !> molecule + type(coord),intent(inout) :: mol + !> LOCAL + real(wp),parameter :: thr = 1.0E-6_wp + real(wp),allocatable :: gradient(:,:),numg(:,:) + integer :: io + real(wp) :: energy + + !> calculation + allocate (gradient(3,mol%nat),source=0.0_wp) + call engrad(mol,calc,energy,gradient,io) + + call numgrad(mol,calc,numgradient=numg) + + if (any(abs(gradient-numg) > thr)) then + call test_failed(error,"Gradient does not match") + call calc%info(stdout) + print '(3es20.13)',gradient + print '(a)',"---" + print '(3es20.13)',numg + print '(a)',"---" + print '(3es20.13)',gradient-numg + end if + end subroutine test_g + +!========================================================================================! +!========================================================================================! +end module test_helpers diff --git a/test/main.f90 b/test/main.f90 index b44f5db0..900cf20a 100644 --- a/test/main.f90 +++ b/test/main.f90 @@ -14,6 +14,11 @@ program tester character(len=:), allocatable :: suite_name, test_name type(testsuite_type), allocatable :: testsuites(:) character(len=*), parameter :: fmt = '("#", *(1x, a))' + external ompmklset,openblasset + + !> only run on one thread + call ompmklset(1) + call openblasset(1) stat = 0 diff --git a/test/test_CN.F90 b/test/test_CN.F90 index 971118be..09b0feb9 100644 --- a/test/test_CN.F90 +++ b/test/test_CN.F90 @@ -1,7 +1,7 @@ module test_CN use testdrive,only:new_unittest,unittest_type,error_type,check,test_failed use crest_parameters - use testmol + use crest_testmol use strucrd use crest_cn_module use miscdata,only:RCOV !> D3 covalent radii diff --git a/test/test_gfn0.F90 b/test/test_gfn0.F90 index cff5e503..10801996 100644 --- a/test/test_gfn0.F90 +++ b/test/test_gfn0.F90 @@ -3,7 +3,7 @@ module test_gfn0 use crest_parameters use crest_calculator use strucrd - use testmol + use crest_testmol implicit none private diff --git a/test/test_gfn0occ.F90 b/test/test_gfn0occ.F90 index e4c5c635..29f11ddd 100644 --- a/test/test_gfn0occ.F90 +++ b/test/test_gfn0occ.F90 @@ -3,7 +3,7 @@ module test_gfn0occ use crest_parameters use crest_calculator use strucrd - use testmol + use crest_testmol implicit none private diff --git a/test/test_gfnff.F90 b/test/test_gfnff.F90 index 273147aa..6e5c9d46 100644 --- a/test/test_gfnff.F90 +++ b/test/test_gfnff.F90 @@ -3,7 +3,7 @@ module test_gfnff use crest_parameters use crest_calculator use strucrd - use testmol + use crest_testmol implicit none private diff --git a/test/test_optimization.F90 b/test/test_optimization.F90 index 33595242..6f01e39b 100644 --- a/test/test_optimization.F90 +++ b/test/test_optimization.F90 @@ -3,7 +3,7 @@ module test_optimization use crest_parameters use crest_calculator use strucrd - use testmol + use crest_testmol use optimize_module implicit none private diff --git a/test/test_tblite.F90 b/test/test_tblite.F90 index d04030d4..fecefd74 100644 --- a/test/test_tblite.F90 +++ b/test/test_tblite.F90 @@ -3,7 +3,8 @@ module test_tblite use crest_parameters use crest_calculator use strucrd - use testmol + use crest_testmol, only: get_testmol + use test_helpers, only: test_e, test_g implicit none private @@ -323,64 +324,23 @@ subroutine test_gfn2_sp_alpb(error) real(wp) :: energy real(wp),allocatable :: grad(:,:) integer :: io -!&< - real(wp),parameter :: e_ref = -42.150818113966622_wp - real(wp),parameter :: g_ref(3,24) = reshape([& - & -0.004041852805369_wp, -0.001459116937018_wp, 0.000004212952013_wp, & - & 0.005431782185647_wp, -0.026769409144275_wp, -0.000053933849249_wp, & - & 0.005232547908947_wp, 0.019316152153876_wp, 0.000051828956087_wp, & - & 0.003984299183311_wp, 0.004654018323578_wp, -0.000031672641741_wp, & - & -0.034791239964625_wp, -0.009664440508457_wp, -0.000039268100546_wp, & - & 0.006792385075909_wp, -0.003127178836761_wp, 0.000032791144117_wp, & - & 0.015306198183764_wp, 0.005195424722641_wp, 0.000035383591075_wp, & - & -0.011644038936970_wp, 0.009526167376125_wp, -0.000103656945404_wp, & - & -0.001073718470205_wp, -0.010467260905049_wp, 0.000071170633309_wp, & - & -0.012208257598543_wp, 0.007792225857756_wp, -0.000026835529946_wp, & - & 0.024297093142032_wp, -0.020057317289964_wp, -0.000036190038701_wp, & - & 0.002288207714506_wp, 0.015784323612706_wp, -0.000015109378387_wp, & - & -0.001839503827186_wp, -0.003557956433963_wp, 0.000003971003294_wp, & - & -0.006475695156935_wp, 0.007869132396390_wp, -0.000061014145496_wp, & - & -0.001323378271276_wp, 0.002797437673167_wp, 0.000004384755727_wp, & - & 0.002794743156382_wp, 0.000752555767144_wp, 0.003757718239733_wp, & - & 0.002796550406646_wp, 0.000753562108628_wp, -0.003760695667456_wp, & - & -0.003950802127381_wp, 0.008247313874474_wp, 0.000028580331243_wp, & - & 0.007699255283409_wp, 0.001924889526582_wp, 0.000000878165662_wp, & - & 0.000911988480912_wp, -0.000170582007313_wp, 0.003208806647171_wp, & - & 0.000936315963916_wp, -0.000147196304551_wp, -0.003212846696159_wp, & - & -0.002208060498652_wp, -0.009259192346010_wp, 0.000102993956974_wp, & - & 0.000531577240056_wp, 0.000047927691044_wp, 0.002360617394228_wp, & - & 0.000553603731705_wp, 0.000018519629250_wp, -0.002322114777547_wp & - & ], shape(g_ref)) -!&> + real(wp),parameter :: e_ref = -23.983234299793384_wp !> setup call sett%create('gfn2') sett%solvmodel = 'alpb' sett%solvent = 'water' call calc%add(sett) - call get_testmol('caffeine',mol) - allocate (grad(3,mol%nat)) + call get_testmol('cytosine',mol) - !> calculation - call engrad(mol,calc,energy,grad,io) - !write(*,'(F25.15)') energy - !write(*,'(3F25.15)') grad - call check(error,io,0) + !> energy + call test_e(mol,calc,error,e_ref) if (allocated(error)) return - call check(error,energy,e_ref,thr=1e-7_wp) + !> gradient + call test_g(mol,calc,error) if (allocated(error)) return - - if (any(abs(grad-g_ref) > thr2)) then - call test_failed(error,"Gradient of energy does not match") - print'(3es21.14)',grad - print'("---")' - print'(3es21.14)',g_ref - print'("---")' - print'(3es21.14)',grad-g_ref - end if - - deallocate (grad) + end subroutine test_gfn2_sp_alpb !========================================================================================! diff --git a/test/testmol.f90 b/test/testmol.f90 index f39d46c4..452fef0c 100644 --- a/test/testmol.f90 +++ b/test/testmol.f90 @@ -1,9 +1,12 @@ -module testmol +module crest_testmol !> coffeine use iso_fortran_env,only:wp => real64 use strucrd implicit none private + + public :: get_testmol + !&< integer,parameter :: caffeine_nat = 24 integer, parameter :: caffeine_at(caffeine_nat) = [6,7,6,7,6,6,6,8,7,6,8,7,6,6, & @@ -41,7 +44,7 @@ module testmol integer,parameter :: methane_nat = 5 integer, parameter :: methane_at(methane_nat) = [6,1,1,1,1] real(wp),parameter :: methane_xyz(3,methane_nat) = reshape(& - & [-2.901604086313, 2.032342621828, -0.000007558904, & + & [-2.901604086313, 2.032342621828, -0.000007558904, & & -4.142827301385, 1.660246889672, 1.875960807537, & & -4.354204487169, 0.990001535591, -1.470244961017, & & -3.376685347364, 4.088767344235, -0.405769514737, & @@ -50,32 +53,59 @@ module testmol !&> - public :: get_testmol +!&< + !> distorted methane + integer,parameter :: cytosine_nat = 13 + integer, parameter :: cytosine_at(cytosine_nat) = [8,6,7,6,6,6,7,7,1,1,1,1,1] + real(wp),parameter :: cytosine_xyz(3,cytosine_nat) = reshape(& + & [-4.142195348814, 2.008151058305, -0.018151734373, & + & -2.160173249661, 0.802767457051, -0.000058193762, & + & -2.268542712629, -1.794135272435, 0.003855688769, & + & -0.191488773092, -3.309463007997, -0.005095763012, & + & 2.109332653259, -2.284418067990, -0.007062235327, & + & 2.185078861327, 0.516677179272, 0.028019148471, & + & 4.467560431809, 1.727180498582, 0.071380211323, & + & 0.177657703530, 1.926043596048, 0.012000916144, & + & -4.036103295159, -2.521391305153, 0.014335396651, & + & -0.507864921184, -5.333664751031, -0.008697813741, & + & 3.837497023245, -3.367210871956, -0.007065809214, & + & 5.961039176371, 0.856469245914, -0.742491063662, & + & 4.318834327087, 3.589804055892, -0.368535366892],& + & shape(cytosine_xyz)) +!&> contains subroutine get_testmol(name,mol) character(len=*),intent(in) :: name type(coord),intent(out) :: mol - select case(name) - case('methane') + select case (name) + case ('methane') mol%nat = methane_nat - allocate(mol%at(mol%nat)) + allocate (mol%at(mol%nat)) mol%at(:) = methane_at(:) - allocate(mol%xyz(3,mol%nat)) + allocate (mol%xyz(3,mol%nat)) mol%xyz(:,:) = methane_xyz(:,:) mol%chrg = 0 mol%uhf = 0 + case ('cytosine') + mol%nat = cytosine_nat + allocate (mol%at(mol%nat)) + mol%at(:) = cytosine_at(:) + allocate (mol%xyz(3,mol%nat)) + mol%xyz(:,:) = cytosine_xyz(:,:) + mol%chrg = 0 + mol%uhf = 0 case default !> caffeine mol%nat = caffeine_nat - allocate(mol%at(mol%nat)) - mol%at(:) = caffeine_at(:) - allocate(mol%xyz(3,mol%nat)) + allocate (mol%at(mol%nat)) + mol%at(:) = caffeine_at(:) + allocate (mol%xyz(3,mol%nat)) mol%xyz(:,:) = caffeine_xyz(:,:) mol%chrg = 0 mol%uhf = 0 end select end subroutine get_testmol -end module testmol +end module crest_testmol