SystemData.F90 Source File


Contents

Source Code


Source Code

module SystemData

    use constants, only: n_int, int64, dp, NEL_UNINITIALIZED
    use MemoryManager, only: TagIntType

    implicit none

    save

    integer :: symmax ! Max number of irreps to deal with. Value computed in GETFCIBASIS readint.f90
    logical :: called_as_lib  !True if the code has been called as library procedure
    logical :: tMolpro  !True if the code has been called from Molpro
    logical :: tMolproMimic !True if the code is being run from standalone neci, but designed to mimic the runtime
    !behaviour of molpro
    character(12) :: MolproID

    logical :: tNoSingExcits    !True if there are no single excitations in the system
    logical :: t_mol_3_body     ! using molecular 3-body transcorr. matels
    logical :: t_exclude_3_body_excits = .false.
    logical :: t_exclude_pure_parallel = .false.
    logical :: t_ueg_transcorr, t_ueg_dump, t_ueg_3_body
    logical :: tSmallBasisForThreeBody = .true.     ! using  3-body transcorr. matels for ueg and ultracold atoms
    logical :: tStarBin, tReadInt, tHFOrder, tDFRead, tPBC, tUEG, tUEG2, tCPMD, tHUB, tHeisenberg
    logical :: tHPHF, tHPHFInts, tUHF, tSPN, tParity, tUseBrillouin, tExch, tReal
    logical :: tTilt, tOneElIntMax, tOnePartOrbEnMax, tROHF, tBrillouinsDefault
    logical :: tNoBrillouin, tVirtCoulombMax, tVirtExchangeMin, tHijSqrdMin
    logical :: tDiagonalizehij, tHFSingDoubExcMax, tSpinOrbs, tReadInCoeff
    logical :: tUseMP2VarDenMat, tAlpha, tStoreAsExcitations, tBin
    logical :: tVASP, tOffDiagSqrdMin, tOffDiagSqrdMax, tOffDiagmax, tShakeDelay
    logical :: tSeparateOccVirt, tExactSizeSpace, tRotatedOrbs
    logical :: tImportanceSample, tERLocalization, tOffDiagMin, tFindCINatOrbs
    logical :: tNoRenormRandExcits, tAssumeSizeExcitgen, tCycleOrbs, tROIteration
    logical :: tShakeIter, tRotateOccOnly, tDoubExcMin, tUseHFOrbs, tRotateOrbs
    logical :: tNonUniRandExcits, tNoSymGenRandExcits, tLagrange, tShakeApprox
    logical :: tShake, tRotateVirtOnly, tMaxHLGap
    logical :: tKPntSym        !Are we using KPoint symmetry?
    logical :: tRotatedOrbsReal     !This means we are reading in a complex FCIDUMP, but all
    !orbitals have been rotated to be real. This requires all
    !kpoints to be at the gamma point or BZ boundary.
    !At the reading in, the integrals will be converted to reals,
    !but kpoint symmetry can still be used.
    logical :: tReadFreeFormat, tReltvy

    logical :: tRIIntegrals   ! Read in RI 2-e integrals from RIDUMP file
    logical :: tStoreSpinOrbs ! This is set when the orbitals are stored in
    ! spin-orbital notation

    logical :: tPickVirtUniform ! Use the 3rd generation, random excitation
    ! generators, which pick pairs of virtual orbitals
    ! at random (but uniformly)

    logical :: tISKFuncs      ! Only for use in systems where the kpoint mesh has inversion symmetry,this ensures all
    ! integrals are real.
    logical :: tOddS_HPHF     !If this is true, and you are using HPHF, then it will converge onto an Odd S HPHF state.
    logical :: tAntisym_MI    !Antisymmetric MI functions.
    logical :: tComplexOrbs_RealInts    !We are using complex orbitals, but real integrals.
    logical :: t_complex_ints = .true.
    !Therefore, check the mom sym before looking up integral,
    !since we only have 4x perm sym.
    logical :: tComplexWalkers_RealInts !We are using real orbitals, but complex walkers
    integer :: iParity(5), nMaxX, nMaxY, nMaxZ, nMSH, coulDampOrb, elecPairs
    integer :: roIterMax, iRanLuxLev, DiagMaxMinFac, OneElmaxMinFac, iState
    integer :: iTiltX, iTiltY, nOccAlpha, nOccBeta, ShakeIterMax, ShakeStart
    integer, parameter :: nIrreps = 8
    integer :: nClosedOrbs(nIrreps), nOccOrbs(nIrreps), irrepOrbOffset(nIrreps)
    integer :: MaxMinFac, MaxABPairs
    real(dp) :: BOX, BOA, COA, fUEGRs, fRc, OrbECutoff, UHUB, BHUB, btHub
    real(dp) :: Diagweight, OffDiagWeight, OrbEnMaxAlpha, Alpha, fCoulDampBeta
    real(dp) :: fCoulDampMu, TimeStep, ConvergedForce, ShakeConverged, UMATEps
    real(dp) :: OneElWeight

    integer :: AA_elec_pairs, BB_elec_pairs, par_elec_pairs, AB_elec_pairs
    integer :: AA_hole_pairs, BB_hole_pairs, par_hole_pairs, AB_hole_pairs
    integer :: hole_pairs, nholes_a, nholes_b, nholes

    integer :: nEl = NEL_UNINITIALIZED             ! Number of (non-frozen) electrons in the system
    integer :: Stot            ! Restrict S to Stot when using CSFs
    integer :: LMS             ! Restrict determinants/CSFs to Ms == LMS


! Calculate size of FCI determinant space using MC
    logical :: tMCSizeSpace, tMCSizeTruncSpace
    integer :: iMCCalcTruncLev
    integer(int64) :: CalcDetPrint, CalcDetCycles   ! parameters

! Inputs for the UEG
    logical :: tUEGTrueEnergies ! This is the logical for use of unscaled energies in the UEG calculation; will normally break spawning
    logical :: tLatticeGens   ! Use new UEG excitation generators
    logical :: t_uniform_excits = .false.
    logical :: t_mixed_excits = .false.
    logical :: tNoFailAb
    logical :: tUEGOffset     ! Use twisted boundary conditions
    real(dp) :: k_offset(3)      ! UEG parameter for twist-averaging
    logical :: tUEGSpecifyMomentum ! UEG parameter to allow specification of total momentum
    integer :: k_momentum(3) ! UEG parameter for total momentum
    logical :: tOrbECutoff ! Whether we're using a spherical cutoff in momentum space or not
    logical :: tgCutoff ! Whether we're using a spherical cutoff for the momentum transfer vector
    real(dp) :: gCutoff ! Spherical cutoff for the momentum transfer vector
    logical :: tMP2UEGRestrict ! Restricts the MP2 sum over a single electron pair, specified by:
    integer :: kiRestrict(3), kjRestrict(3) ! ki/kj pair
    integer :: kiMsRestrict, kjMsRestrict ! and their spins
    logical :: tMadelung ! turning on self-interaction term
    real(dp) :: Madelung ! variable storage for self-interaction term
    logical :: tUEGFreeze ! Freeze core electrons for the UEG, a crude hack for this to work-around freezing not working for UEG
    real(dp) :: FreezeCutoff
    logical :: tRef_Not_HF
    logical :: tTranscorr, tRPA_tc, tInfSumTCCalc, tInfSumTCPrint, tInfSumTCRead
    integer :: TranscorrCutoff, TranscorrIntCutoff
    real(dp) :: PotentialStrength, TranscorrGaussCutoff
    logical :: tContact, tUnitary, tTrcorrExgen, tTrCorrRandExgen, t_trcorr_gausscutoff, Tperiodicinmom !used for ultracold atoms

! Inputs for the UEG2
    character(len=3) :: real_lattice_type ! type of reciprocal lattice (eg. fcc, sc, bcc, hcp)
    integer :: k_lattice_vectors(3, 3)
    real(dp) :: k_lattice_constant
    integer, allocatable :: kvec(:, :)
    integer ::  Highest_orb_index
    integer :: dimen

! Matrix elements for the modified hubbard model (including breathing effect)
    real(dp), allocatable :: breathingCont(:)
    integer, allocatable :: momIndexTable(:, :, :, :)
    logical :: tmodHub

! For the UEG, we damp the exchange interactions.
!    0 means none
!    1 means screened (using an erfc)
!    2 means hard spherical cut-off (at a distance Rc=ALAT(4))
!      [see JSS, ASA PRB 77, 193110 (2008)]
    integer :: iPeriodicDampingType

! Used to be stored in Integrals
    INTEGER :: ORBORDER(8, 2)

    logical :: tFixLz   ! Fix Lz of determinants in FCIMC. Lz == LzTot
    integer :: LzTot    ! Total Ml quantum number of state to converge on.
    integer :: iMaxLz   ! abs(maximum Ml basis function))

    integer :: nIfP     ! Size appended to nIfD in CASSTAR calculations. Keeps
    ! track of the parent determinant of spawned walkers.

! From NECICB
    integer :: lmsBasis

! hm.. for hubbard/UEG systems with >= 64 orbitals we need more integers
! to store since 2^63-1 is the max 64bit integer. but i dont know yet what
! changes that introduces in the rest of the code... additionally this change
! does not only depend on the number of orbitals, but on the number of
! symmetry labels, since for molecular systems this is usually much smaller
! than the number of orbitals.. so in this case no change is necessary..
! and the problem here is, we do not know yet the number of orbitals in
! the compilation stage.. so i would have to make it allocatable..
! hm.. can i think of a nice workaround??
    TYPE Symmetry
        SEQUENCE
        integer(int64) :: S
    END TYPE

    integer, PARAMETER :: SymmetrySize = 2
    integer, PARAMETER :: SymmetrySizeB = SymmetrySize * 8
    TYPE :: BasisFN
        TYPE(Symmetry) :: sym
        INTEGER :: k(3)
        INTEGER :: Ms
            !! is -1 for beta, and 1 for alpha
        INTEGER :: Ml            !This is the Ml symmetry of the orbital
        INTEGER :: Dummy         !Rather than use SEQUENCE which has caused endless bother...
    END TYPE


    interface get_BasisFn
        module procedure construct_basisfn
    end interface

! Empty basis function is used in many places.
! This is useful so if BasisFn changes, we don't have to go
! through the code and change the explicit null statements.
    type(BasisFn) :: NullBasisFn = BasisFn(Symmetry(0), (/0, 0, 0/), 0, 0, 0)

    integer, PARAMETER :: BasisFNSize = SymmetrySize + 5
    integer, PARAMETER :: BasisFNSizeB = BasisFNSize * 8

    TYPE(BASISFN) :: SymRestrict
    INTEGER :: nBasisMax(5, 7) = 0
    real(dp) :: ALAT(5)
    real(dp) :: ECore
    INTEGER :: nBasis
        !! The number of spin orbitals.
    integer(int64) :: nBI
    integer :: nMax
    integer :: nnr
    integer :: nocc
    real(dp) :: OMEGA
    logical :: tSpinPolar
    INTEGER :: iSpinSkip ! Often referred to as ISS.

!From Calc
    real(dp) :: Beta

!Renewed for compile

! List of orbital energies.
! Arr(:,1)
!   ordered by energy.  Moreover when we have a set of degenerate orbitals with
!   different symmetry, they are ordered within that set such that orbitals with
!   the same symmetry are next to each other, and then by Ms=-1,1.
!   Arr(10,1) is the energy of the 10th lowest energy
!   spin-orbital.
! Arr(:,2)
!     ordered by spin-orbital index.  Arr(10,2) is the energy of the 10th
!     spin-orbital (given the index scheme in use).
! Reallocated with the correct (new) size during freezing.
    real(dp), pointer :: Arr(:, :)
    INTEGER(TagIntType) :: tagArr

! Lists orbitals in energy order. i.e. Brr(1) is the lowest energy orbital
    INTEGER, pointer :: BRR(:)
    INTEGER(TagIntType) :: tagBrr

    Type(BasisFN), pointer :: G1(:)  ! Info about the basis functions.
    INTEGER(TagIntType) :: tagG1

    INTEGER :: LMS2

!  Set if we turn symmetry off
    LOGICAL :: lNoSymmetry

!Set if we don't reorder the HF orbitals on entry
    LOGICAL :: tHFNoOrder
! When set, ignore differences in orbital energies between pairs of orbitals (which should be beta/alpha)
!  and group them under the same symrep
    LOGICAL :: tSymIgnoreEnergies

! Stoquastize the Hamiltonian. i.e., H_offdiag -> -abs(H_offdiag)
    logical :: tStoquastize

! True if we are performing a calculation in all symmetry sectors at once.
! This is used in finite-temperature KP-FCIQMC calculations.
    logical :: tAllSymSectors

    logical :: tGenHelWeighted, tGen_4ind_weighted, tGen_4ind_reverse
    logical :: tUEGNewGenerator, tGen_4ind_part_exact, tGen_4ind_lin_exact
    logical :: tGen_4ind_2, tGen_4ind_2_symmetric

! Are we using multiple replicas?
    logical :: tMultiReplicas

! Has the user set the symmetry using the 'SYM' option?
    logical :: tSymSet = .false.

! ==================== GUGA Implementation ========================
! input for graphical unitary group approach (GUGA) CSF implementation
    logical :: tGUGA = .false. ! flag to indicate usage of GUGA

! use new flags for the new guga excitation generator implementations
    logical :: tGen_nosym_guga = .false., &
               tGen_sym_guga_ueg = .false., &
               tGen_sym_guga_mol = .false., &
               tgen_guga_weighted = .false., &
               tgen_guga_crude = .false., &
               tgen_guga_mixed = .false., &
               tgen_guga_exchange = .false., &
               t_approx_exchange = .false., &
               t_crude_exchange = .false., &
               t_crude_exchange_noninits = .false., &
               is_init_guga = .false., &
               t_approx_exchange_noninits = .false.

    logical :: t_guga_mixed_init = .true., t_guga_mixed_semi = .false.

    logical :: t_consider_diff_bias = .false.

! also store the number of spatial orbitals here, to use it generally
    integer :: nSpatOrbs

! put in a logical to not reorder the orbitals in the guga + hubbard case
! to directly compare it with the determinental implementation, even if
! this might decrease the efficiency of the guga implmenetation
    logical :: t_guga_noreorder = .false.

! Are we restricting excitations
    logical :: tGAS = .false.

! twisted boundary implementation for the hubbard model:
! use keyword twisted-bc [real, real] in System Block of input
! twist value is in values of periodicity (2*pi/L) for cubic and (pi/L) for
! tilted lattice
    logical :: t_twisted_bc = .false.
    real(dp) :: twisted_bc(3) = 0.0_dp

! flags for the use of open boundary conditions in the real-space
! hubbard model.
! for the cubic lattice the can be set separately, for the tilted only
! full open BC are implemented
    logical :: t_open_bc_x = .false.
    logical :: t_open_bc_y = .false.
    logical :: t_open_bc_z = .false.

! use an intermediate flag for a new implementation of the newest excitation
! generator
    logical :: tGen_4ind_unbound = .false.

! implement a more efficient real-space hubbard implementation
    logical :: t_new_real_space_hubbard = .false.
! make a new flag to indicate the new hubbard implementation
    logical :: t_new_hubbard = .false.

! honjuns idea with the transcorrelated Hamiltonian we have a modified
! hopping term:
! t_ij^s = t exp[K(n_j^s' - n_i^s')]
! so we need this K as an input parameter
    real(dp) :: trans_corr_param = 0.0_dp
! and a flag to start it
    logical :: t_trans_corr = .false.
! for testing purposes:
    logical :: t_trans_corr_new = .false.
! as one can see this modification is dependent on the current
! occupation of the involved hopping orbitals! so it is not just a
! change in the Hamiltonian
    logical :: t_trans_corr_2body
    real(dp) :: trans_corr_param_2body = 0.0_dp

! new transcorrelation implementation with double excitations for the
! real-space hubbard. it comes from a hopping correlation form in real-space
! reuse the trans_corr_param variable though!
    logical :: t_trans_corr_hop = .false.

! hole focusing (one body) excitation generator, designed for Hubbard model at extremely large U ragion.
    logical :: t_hole_focus_excits = .false.
    real(dp) :: pholefocus = 0.5_dp

! simple preconditioner for Hubbard model
    logical :: t_precond_hub = .false.
    logical :: t_no_ref_shift = .false.

    logical :: t12FoldSym = .false.

! and the other lattice models:
    logical :: t_tJ_model = .false.
    logical :: t_heisenberg_model = .false.

! if the hamiltonian supports singles
    logical :: tNoSinglesPossible = .false.

! and also the exchange strength
    real(dp) :: exchange_j = 0.0_dp

! use a general flag for lattice models in the future:
    logical :: t_lattice_model = .false.

! use a new flag for the "new" k-space hubbard implementation
    logical :: t_k_space_hubbard = .false.

! Lookup table for excitation matrix elements
! I had to externalize this from the lattice class to prevent circular dependency
    real(dp), allocatable :: excit_cache(:, :, :)

! also use an additional flag to indicate that 3-body excitations are possible
    logical :: t_3_body_excits = .false.

! make a general Flag to indicat a non-hermitian Hamiltonian
    logical :: t_non_hermitian_2_body = .false.
    logical :: t_non_hermitian_1_body = .false.

! if true, we are actually propagating $H^\dagger$, not $H$
    logical :: t_calc_adjoint = .false.

! and indicate the maximum excitation level:
    integer :: max_ex_level = 2

    character(20) :: lattice_type

! i need
    integer :: length_x = 1, length_y = 1, length_z = 1

! flag for the pre-computed power-pitzer excitaion generator
    logical :: t_pcpp_excitgen = .false.
! flags for the pre-computed heat-bath excitation generator
    logical :: t_fci_pchb_excitgen = .false.
    logical :: t_guga_pchb_weighted_singles = .false.

    logical :: t_guga_pchb = .false.

    ! flag for the impurity excitation generator
    logical :: t_impurity_excitgen = .false.

! also implement a next-nearest neighbor Hubbard model implementation:
! for k-space hubbard, this only affects the diagonal part!
    real(dp) :: nn_bhub = 0.0_dp

! do a quick test with different weightings of picking orbitals (a)
    logical :: t_iiaa = .false., t_ratio = .false.

! spin-dependent transcorrelation
    logical :: t_spin_dependent_transcorr = .false.

! some changes in matrix elements for mixed hubbard basis
    logical :: t_mixed_hubbard = .false.

    logical :: t_olle_hubbard = .false.

    logical :: t_test_double = .false., t_test_single = .false.
    integer :: test_i, test_j, test_k, test_l

! flag for anti-periodic BCs in the real-space Hubbard implementation
    logical :: t_anti_periodic(2) = .false.


! test-flags for guga-pchb testing
    logical :: t_old_pchb = .false.
    logical :: t_exchange_pchb = .false.
    logical :: t_analyze_pchb = .false.


    logical :: t_bipartite_order = .false.
    logical :: t_input_order = .false.
    integer, allocatable :: orbital_order(:)

! Operators for type(symmetry)
    interface assignment(=)
        module procedure SymAssign
    end interface
    interface operator(.eq.)
        module procedure SymEq
    end interface
    interface operator(.ne.)
        module procedure SymNEq
    end interface
    interface operator(.gt.)
        module procedure SymGt
    end interface
    interface operator(.lt.)
        module procedure SymLt
    end interface

    ! The inputted m_s value of spin-restrict
    integer, allocatable :: user_input_m_s

contains
    ! Operations on type(symmetry)
    elemental subroutine SymAssign(lhs, rhs)
        type(Symmetry), intent(out) :: lhs
        type(Symmetry), intent(in) :: rhs
        lhs%S = rhs%S
    end subroutine
    elemental logical function SymEq(a, b)
        type(Symmetry), intent(in) :: a, b
        SymEq = a%S == b%S
    end function
    elemental logical function SymNEq(a, b)
        type(Symmetry), intent(in) :: a, b
        SymNEq = a%S /= b%S
    end function
    elemental logical function SymGt(a, b)
        type(Symmetry), intent(in) :: a, b
        SymGt = a%S > b%S
    end function
    elemental logical function SymLt(a, b)
        type(Symmetry), intent(in) :: a, b
        SymLt = a%S < b%S
    end function

    pure function construct_basisfn(mdk) result(res)
        integer, intent(in) :: mdk(5)
        type(BasisFN) :: res
        res = BasisFN(Symmetry(int(mdk(1), int64)), mdk(2:4), mdk(5), 0, 0)
    end function

end module SystemData