Skip to content

Commit

Permalink
Add 3d bio benchmark
Browse files Browse the repository at this point in the history
  • Loading branch information
jeanlucf22 committed Nov 22, 2023
1 parent 09ac6ee commit de391f8
Show file tree
Hide file tree
Showing 5 changed files with 718 additions and 17 deletions.
5 changes: 4 additions & 1 deletion benchmarks/CMakeLists.txt
Original file line number Diff line number Diff line change
Expand Up @@ -29,11 +29,14 @@ progress_benchmark(dmconstruction dmconstruction/dmconstruction.F90)

progress_benchmark(dmconstruction3d dmconstruction3d/dmconstruction3d.F90)

progress_benchmark(dmconstruction_bio dmconstruction3d/dmconstruction_bio.F90
dmconstruction_graphBased/aux_mod.F90)

progress_benchmark(dmconstruction_gp dmconstruction_graphBased/dmconstruction_graphBased.F90)

progress_benchmark(dmconstruction_gpbio dmconstruction_graphBased/dmconstruction_graphBased_bio.F90 dmconstruction_graphBased/aux_mod.F90)

SET(EXECUTABLE_OUTPUT_PATH ${PROJECT_BINARY_DIR})

install(TARGETS dmconstruction
install(TARGETS dmconstruction dmconstruction_bio
DESTINATION ${CMAKE_INSTALL_PREFIX}/bin)
151 changes: 151 additions & 0 deletions benchmarks/dmconstruction3d/dmconstruction_bio.F90
Original file line number Diff line number Diff line change
@@ -0,0 +1,151 @@
!> Graph-based aproach driver.
!!
program biosolve

use bml
use aux_mod
use prg_sp2_mod

!PROGRESS lib modes
use prg_modelham_mod
use prg_system_mod
use prg_timer_mod
use prg_extras_mod
use prg_parallel_mod
use prg_progress_mod
use prg_densitymatrix_mod
use ham_latte_mod
use tbparams_latte_mod
use ppot_latte_mod
use prg_ptable_mod
use prg_genz_mod
use prg_nonortho_mod

integer, parameter :: dp = kind(1.0d0)
character(2), allocatable :: TypeA(:,:), TypeB(:,:)
character(3), allocatable :: intKind(:)
integer :: myRank, nel, norbs, nnz
integer, allocatable :: hindex(:,:)
real(dp) :: bndfil, ef, mlssp2, mlsi
real(dp) :: mlsdiag, sparsity, threshold
real(dp), allocatable :: onsitesH(:,:), onsitesS(:,:), origin(:), trace(:)
type(bioham_type) :: bioham
type(bml_matrix_t) :: aux_bml, ham_bml, oham_bml
type(bml_matrix_t) :: over_bml, rho_bml
type(intpairs_type), allocatable :: intPairsH(:,:), intPairsS(:,:)
type(ppot_type), allocatable :: ppot(:,:)
type(system_type) :: sy, syf
type(tbparams_type) :: tb
real(dp) :: tol
real(dp), allocatable :: eigenvalues(:)

call prg_progress_init()
myRank = getMyRank() + 1

! Parsing input file
call prg_parse_bioham(bioham,"input.in") !Reads the input for modelham

! Reading the system
call prg_parse_system(sy,"prot.pdb")

call prg_replicate_system(sy,syf,bioham%replicatex,bioham%replicatey,bioham%replicatez)
call prg_destroy_system(sy)

! Center sytem inside the box and fold it by the lattice_vectors.
allocate(origin(3)); origin = 0.0_dp
call prg_translateandfoldtobox(syf%coordinate,syf%lattice_vector,origin)

call prg_write_system(syf,"protf.pdb")

! Constructing the Hamiltonian
call load_latteTBparams(tb,syf%splist,bioham%parampath)

! Get the mapping of the Hamiltonian index with the atom index
allocate(hindex(2,syf%nats))


! Bond integrals parameters for LATTE Hamiltonian.
call load_bintTBparamsH(syf%splist,tb%onsite_energ,&
typeA,typeB,intKind,onsitesH,onsitesS,intPairsH,intPairsS,bioham%parampath)

call write_bintTBparamsH(typeA,typeB,&
intKind,intPairsH,intPairsS,adjustl(trim(bioham%jobname))//"_mybondints.nonorth")

! Load Pair potentials for LATTE TB.
call load_PairPotTBparams(bioham%parampath,syf%splist,ppot)

call get_hindex(syf%spindex,tb%norbi,hindex,norbs)

call bml_zero_matrix(bioham%bml_type,bml_element_real,dp,norbs,norbs,ham_bml)
call bml_zero_matrix(bioham%bml_type,bml_element_real,dp,norbs,norbs,over_bml)

call get_hsmat(ham_bml,over_bml,syf%coordinate,&
syf%lattice_vector,syf%spindex,&
tb%norbi,hindex,onsitesH,onsitesS,intPairsH,intPairsS,bioham%threshold)

if(bioham%mdim == 0) bioham%mdim = norbs
! Get occupation based on last shell population.
nel = sum(element_numel(syf%atomic_number(:)),&
& size(syf%atomic_number,dim=1))
bndfil = nel/(2.0_dp*real(norbs,dp))

call bml_threshold(ham_bml,bioham%threshold)

if(myRank == 1)call bml_print_matrix("ham_bml",ham_bml,0,10,0,10)
sparsity = bml_get_sparsity(ham_bml,bioham%threshold)
if(myRank == 1)write(*,*)"Sparsity Ham=",sparsity

call bml_zero_matrix(bioham%bml_type,bml_element_real,dp,norbs,norbs,aux_bml)

call prg_buildzdiag(over_bml,aux_bml,bioham%threshold,bioham%mdim,bioham%bml_type)
if(myRank == 1)call bml_print_matrix("zmat",aux_bml,0,10,0,10)
call bml_deallocate(over_bml)

call bml_zero_matrix(bioham%bml_type,bml_element_real,dp,norbs,norbs,oham_bml)
call prg_orthogonalize(ham_bml,aux_bml,oham_bml,&
bioham%threshold,bioham%bml_type,bioham%verbose)
call bml_deallocate(ham_bml)

call bml_zero_matrix(bioham%bml_type,bml_element_real,dp,norbs,norbs,rho_bml)
! Call SP2
mlsi = mls()
tol = 2.0D-5*norbs*bndfil
call prg_sp2_alg1(oham_bml, rho_bml, 1.0D-5, bndfil, 15,100, "Rel", tol, 20)
mlssp2 = mls()-mlsi

call bml_deallocate(aux_bml)
call bml_zero_matrix(bioham%bml_type,bml_element_real,dp,norbs,norbs,aux_bml)
allocate(eigenvalues(norbs))

! Construct the density matrix from diagonalization of full matrix to compare with
mlsi = mls()
call prg_build_density_T0(oham_bml,aux_bml,bioham%threshold, bndfil, eigenvalues)
mlsdiag = mls()-mlsi

! count number of non-zeros in DM
nnz = 0
do i=1,norbs
nnz = nnz + bml_get_row_bandwidth(rho_bml,i)
enddo

if(myRank == 1)call bml_print_matrix("rhoSP2",rho_bml,0,10,0,10)
if(myRank == 1)call bml_print_matrix("rhoDIAG",aux_bml,0,10,0,10)
call bml_add(aux_bml,rho_bml,1.0d0,-1.0d0,threshold)

if(myRank == 1)then
write(*,*)"Nnz in DM = ",nnz
write(*,*)"DM sparsity = ",1.0D0-real(nnz)/real(norbs*norbs)
write(*,*)"Threshold = ",bioham%threshold
write(*,*)"Number of replicas = ",bioham%replicatex*bioham%replicatey*bioham%replicatez
write(*,*)"Number of atoms = ",syf%nats
write(*,*)"Number of orbitals = ",norbs
write(*,*)"Time for SP2 = ",mlssp2
write(*,*)"Time for Diagonalization = ",mlsdiag
write(*,*)"Speedup = ",mlsdiag/mlssp2
write(*,*)"Error DM = ",bml_fnorm(aux_bml)/real(norbs*norbs,dp)
endif

call bml_deallocate(aux_bml)
call bml_deallocate(rho_bml)

end program biosolve
11 changes: 11 additions & 0 deletions benchmarks/dmconstruction3d/input.in.bio
Original file line number Diff line number Diff line change
@@ -0,0 +1,11 @@

BIOHAM{
BMLType= Ellpack
ReplicateX= 1
ReplicateY= 1
ReplicateZ= 1
Threshold= 1.0E-6
SystemFileName= 'prot.pdb'
ParamPath= '../../examples/latteTBparams/'
}

Loading

0 comments on commit de391f8

Please sign in to comment.