HΦ
3.2.0
|
Definision of system (Hamiltonian) etc. More...
#include <struct.h>
Data Fields | |
char * | CDataFileHead |
Read from Calcmod in readdef.h. Header of output file such as Green's function. More... | |
char * | CParaFileHead |
Read from Calcmod in readdef.h. It is not used. Just for the compatibility to mVMC. More... | |
unsigned int | nvec |
Read from Calcmod in readdef.h. More... | |
unsigned int | k_exct |
Read from Calcmod in readdef.h. More... | |
int | LanczosEps |
log(10 base) of the convergence threshold. Read from Calcmod in readdef.h More... | |
int | LanczosTarget |
Which eigenstate is used to check convergence. Read from Calcmod in readdef.h. More... | |
int | read_hacker |
Whether use an efficient method (=1) in sz.c or not (=0) More... | |
int | READ |
It is ALWAYS 0 ??? More... | |
int | WRITE |
It is ALWAYS 0 ??? More... | |
unsigned int | Nsite |
Number of sites in the INTRA process region. More... | |
unsigned int | NsiteMPI |
Total number of sites, differ from DefineList::Nsite. More... | |
unsigned int | Nup |
Number of spin-up electrons in this process. More... | |
unsigned int | Ndown |
Number of spin-down electrons in this process. More... | |
unsigned int | NupMPI |
Total number of spin-up electrons across processes. Deffer from DefineList::Nup. Read from modpara in readdef.h. More... | |
unsigned int | NdownMPI |
Total number of spin-down electrons across processes. Deffer from DefineList::Ndown. Read from modpara in readdef.h. More... | |
unsigned int | NupOrg |
Number of spin-up electrons before exitation. Used only in the spectrum calculation. Read from modpara in readdef.h. More... | |
unsigned int | NdownOrg |
Number of spin-down electrons before exitation. Used only in the spectrum calculation. Read from modpara in readdef.h. More... | |
int | Total2Sz |
Total \(2S_z\) in this process. More... | |
int | Total2SzMPI |
Total \(2S_z\) across processes. More... | |
unsigned int | Ne |
Number of electrons in this process. More... | |
unsigned int | NeMPI |
Total number of electrons across process. Differ from DefineList::Ne . More... | |
unsigned int | Lanczos_max |
Maximum number of iterations. More... | |
int | Lanczos_restart |
Number of iterations performed in the restart computation. More... | |
long int | initial_iv |
Seed of random number for initial guesss of wavefunctions. More... | |
int | istep |
Index of TPQ step ??? More... | |
int | irand |
Input keyword TargetTPQRand ??? More... | |
int | St |
0 or 1, but it affects nothing. More... | |
int * | LocSpn |
[DefineList::NLocSpn] Flag (and size) of the local spin. malloc in setmem_def(). More... | |
unsigned int | NLocSpn |
Number of local spins. More... | |
unsigned int | NCond |
Number of itinerant electrons. More... | |
int | iFlgGeneralSpin |
Flag for the general (Sz/=1/2) spin. More... | |
int | iFlgSzConserved |
Flag whether Sz is conserved. More... | |
int | fidx |
Always 0, it is not used ??? More... | |
long unsigned int * | Tpow |
[2 * DefineList::NsiteMPI] \(2^n\) malloc in setmem_def(). More... | |
long unsigned int * | OrgTpow |
[2 * DefineList::NsiteMPI] \(2^n\) malloc in setmem_def(). More... | |
long int * | SiteToBit |
[DefineList::NsiteMPI] Similar to DefineList::Tpow. For general spin. More... | |
unsigned int | EDNChemi |
Number of on-site term. More... | |
int * | EDChemi |
[DefineList::Nsite] Chemical potential. malloc in setmem_def(). More... | |
int * | EDSpinChemi |
[DefineList::Nsite] More... | |
double * | EDParaChemi |
[DefineList::Nsite] On-site potential parameter. malloc in setmem_def(). More... | |
unsigned int | NTransfer |
Number of transfer integrals obtained by a def file. More... | |
unsigned int | EDNTransfer |
Number of transfer integrals for calculation. More... | |
int ** | GeneralTransfer |
Index of transfer integrals obtained by a def file. malloc in setmem_def(). Data Format [DefineList::NTransfer][4]: 0->site number i, 1-> spin index on i, 2-> site number j, 3-> spin index on j. More... | |
int ** | EDGeneralTransfer |
Index of transfer integrals for calculation. malloc in setmem_def(). Data Format [DefineList::NTransfer][4]: 0->site number i, 1-> spin index on i, 2-> site number j, 3-> spin index on j. More... | |
double complex * | ParaGeneralTransfer |
Value of general transfer integrals by a def file. malloc in setmem_def(). Data Format [DefineList::NTransfer]. More... | |
double complex * | EDParaGeneralTransfer |
Value of general transfer integrals by a def file. malloc in setmem_def(). Data Format [DefineList::NTransfer]. More... | |
unsigned int | NCoulombIntra |
int ** | CoulombIntra |
double * | ParaCoulombIntra |
unsigned int | NCoulombInter |
Number of off-site Coulomb interaction. More... | |
int ** | CoulombInter |
double * | ParaCoulombInter |
[DefineList::NCoulombInter]Coupling constant of off-site Coulomb interaction. malloc in setmem_def(). More... | |
unsigned int | NHundCoupling |
Number of Hund coupling. More... | |
int ** | HundCoupling |
[DefineList::NHundCoupling][2] Index of Hund coupling. malloc in setmem_def(). More... | |
double * | ParaHundCoupling |
[DefineList::NHundCoupling] Hund coupling constant. malloc in setmem_def(). More... | |
unsigned int | NPairHopping |
Number of pair-hopping term. More... | |
int ** | PairHopping |
[DefineList::NPairHopping][2] Index of pair-hopping. malloc in setmem_def(). More... | |
double * | ParaPairHopping |
[DefineList::NPairHopping] Coupling constant of pair-hopping term. malloc in setmem_def(). More... | |
unsigned int | NExchangeCoupling |
Number of exchange term. More... | |
int ** | ExchangeCoupling |
[DefineList::NExchangeCoupling][2] Index of exchange term. malloc in setmem_def(). More... | |
double * | ParaExchangeCoupling |
[DefineList::NExchangeCoupling] Coupling constant of exchange term. malloc in setmem_def(). More... | |
unsigned int | NIsingCoupling |
Number of Ising term. More... | |
unsigned int | NPairLiftCoupling |
Number of pair-lift term. More... | |
int ** | PairLiftCoupling |
[DefineList::NPairHopping][2] Index of pair-lift term. malloc in setmem_def(). More... | |
double * | ParaPairLiftCoupling |
[DefineList::NPairHopping] Coupling constant of pair-lift term. malloc in setmem_def(). More... | |
int ** | InterAll |
[DefineList::NinterAll][8] Interacted quartet More... | |
int ** | InterAll_OffDiagonal |
[DefineList::NinterAll_OffDiagonal][8] Interacted quartet More... | |
int ** | InterAll_Diagonal |
[DefineList::NinterAll_Diagonal][4] Interacted quartet More... | |
unsigned int | NInterAll |
Total Number of Interacted quartet. More... | |
unsigned int | NInterAll_Diagonal |
Number of interall term (diagonal) More... | |
unsigned int | NInterAll_OffDiagonal |
Number of interall term (off-diagonal) More... | |
double complex * | ParaInterAll |
[DefineList::NInterAll] Coupling constant of inter-all term. malloc in setmem_def(). More... | |
double * | ParaInterAll_Diagonal |
[DefineList::NInterAll_Diagonal] Coupling constant of diagonal inter-all term. malloc in setmem_def(). More... | |
double complex * | ParaInterAll_OffDiagonal |
[DefineList::NInterAll_OffDiagonal] Coupling constant of off-diagonal inter-all term. malloc in setmem_def(). More... | |
int ** | CisAjt |
[DefineList::NCisAjt][4] Indices of one-body correlation function. malloc in setmem_def(). More... | |
unsigned int | NCisAjt |
Number of indices of two-body correlation function. More... | |
int ** | CisAjtCkuAlvDC |
[DefineList::NCisAjtCkuAlvDC][4] Indices of two-body correlation function. malloc in setmem_def(). More... | |
unsigned int | NCisAjtCkuAlvDC |
Number of indices of two-body correlation function. More... | |
int ** | SingleExcitationOperator |
[DefineList::NSingleExcitationOperator][3] Indices of single excitaion operator for spectrum. malloc in setmem_def(). More... | |
unsigned int | NSingleExcitationOperator |
Number of single excitaion operator for spectrum. More... | |
double complex * | ParaSingleExcitationOperator |
[DefineList::NSingleExcitationOperator] Coefficient of single excitaion operator for spectrum. malloc in setmem_def(). More... | |
int ** | PairExcitationOperator |
[DefineList::NPairExcitationOperator][5] Indices of pair excitaion operator for spectrum. malloc in setmem_def(). More... | |
unsigned int | NPairExcitationOperator |
Number of pair excitaion operator for spectrum. More... | |
double complex * | ParaPairExcitationOperator |
[DefineList::NPairExcitationOperator] Coefficient of pair excitaion operator for spectrum. malloc in setmem_def(). More... | |
int | iCalcType |
Switch for calculation type. 0:Lanczos, 1:TPQCalc, 2:FullDiag. More... | |
int | iCalcEigenVec |
Switch for method to calculate eigenvectors. 0:Lanczos+CG, 1: Lanczos. default value is set as 0 in readdef.c. More... | |
int | iInitialVecType |
Switch for type of inital vectors. 0:complex type, 1: real type. default value is set as 0 in readdef.c. More... | |
int | iFlgFiniteTemperature |
??? More... | |
int | iCalcModel |
Switch for model. 0:Hubbard, 1:Spin, 2:Kondo, 3:HubbardGC, 4:SpinGC, 5:KondoGC, 6:HubbardNConserved. More... | |
int | iOutputMode |
Switch for output mode. 0: OneBodyG and TwoBodyG. 1: OneBodyG and TwoBodyG and correlations for charge and spin. More... | |
int | iOutputEigenVec |
ASwitch for outputting an eigenvector. 0: no output, 1:output. More... | |
int | iInputEigenVec |
Switch for reading an eigenvector. 0: no input, 1:input. More... | |
int | iOutputHam |
int | iInputHam |
int | iOutputExVec |
double complex | dcOmegaMax |
Upper limit of the frequency for the spectrum. More... | |
double complex | dcOmegaMin |
Lower limit of the frequency for the spectrum. More... | |
double complex | dcOmegaOrg |
Origin limit of the frequency for the spectrum. More... | |
int | iNOmega |
Number of frequencies for spectrum. More... | |
int | iFlgSpecOmegaMax |
Whether DefineList::dcOmegaMax is input or not. More... | |
int | iFlgSpecOmegaMin |
Whether DefineList::dcOmegaMin is input or not. More... | |
int | iFlgSpecOmegaOrg |
Whether DefineList::dcOmegaOrg is input or not. More... | |
int | iFlgCalcSpec |
Input parameter CalcSpec in teh CalcMod file. More... | |
int | iFlagListModified |
When the Hilbert space of excited state differs from the original one. More... | |
int | iReStart |
int | iFlgMPI |
MPI mode. More... | |
int | iNGPU |
GPU mode ( only for FullDiag ) More... | |
int | iFlgScaLAPACK |
ScaLAPACK mode ( only for FullDiag ) More... | |
struct ParamList | Param |
unsigned int | NTETimeSteps |
double * | TETime |
unsigned int | NLaser |
double * | ParaLaser |
unsigned int | NTETransferMax |
unsigned int * | NTETransfer |
unsigned int * | NTETransferDiagonal |
int *** | TETransfer |
int *** | TETransferDiagonal |
double complex ** | ParaTETransfer |
double ** | ParaTETransferDiagonal |
unsigned int | NTEInterAllMax |
unsigned int * | NTEInterAll |
unsigned int * | NTEInterAllOffDiagonal |
unsigned int * | NTEInterAllDiagonal |
int *** | TEInterAll |
int *** | TEInterAllOffDiagonal |
int *** | TEInterAllDiagonal |
double complex ** | ParaTEInterAll |
double complex ** | ParaTEInterAllOffDiagonal |
double ** | ParaTEInterAllDiagonal |
int ** | TEChemi |
unsigned int * | NTEChemi |
int ** | SpinTEChemi |
double ** | ParaTEChemi |
char* DefineList::CDataFileHead |
Read from Calcmod in readdef.h. Header of output file such as Green's function.
Definition at line 42 of file struct.h.
Referenced by CalcByLanczos(), CalcByLOBPCG(), CalcByTEM(), CalcSpectrum(), CalcSpectrumByBiCG(), CalcSpectrumByTPQ(), expec_cisajs(), expec_cisajscktaltdc(), inputHam(), Lanczos_EigenValue(), Lanczos_GetTridiagonalMatrixComponents(), LOBPCG_Main(), output(), outputHam(), OutputLanczosVector(), OutputTMComponents(), OutputTMComponents_BiCG(), ReadDefFileNInt(), ReadInitialVector(), ReadTMComponents(), ReadTMComponents_BiCG(), setmem_HEAD(), SetOmega(), sz(), TimeKeeper(), TimeKeeperWithRandAndStep(), and TimeKeeperWithStep().
int** DefineList::CisAjt |
[DefineList::NCisAjt][4] Indices of one-body correlation function. malloc in setmem_def().
Definition at line 174 of file struct.h.
Referenced by expec_cisajs_Hubbard(), expec_cisajs_HubbardGC(), expec_cisajs_SpinGCGeneral(), expec_cisajs_SpinGCHalf(), expec_cisajs_SpinGeneral(), expec_cisajs_SpinHalf(), ReadDefFileIdxPara(), and setmem_def().
int** DefineList::CisAjtCkuAlvDC |
[DefineList::NCisAjtCkuAlvDC][4] Indices of two-body correlation function. malloc in setmem_def().
Definition at line 177 of file struct.h.
Referenced by expec_cisajscktalt_Hubbard(), expec_cisajscktalt_HubbardGC(), expec_cisajscktalt_SpinGCGeneral(), expec_cisajscktalt_SpinGCHalf(), expec_cisajscktalt_SpinGeneral(), expec_cisajscktalt_SpinHalf(), ReadDefFileIdxPara(), Rearray_Interactions(), and setmem_def().
int** DefineList::CoulombInter |
[DefineList::NCoulombInter][2] Index of off-site coulomb interaction. malloc in setmem_def().
Definition at line 128 of file struct.h.
Referenced by diagonalcalc(), ReadDefFileIdxPara(), and setmem_def().
int** DefineList::CoulombIntra |
[DefineList::NCoulombIntra][1] Index of on-site coulomb interaction. malloc in setmem_def().
Definition at line 122 of file struct.h.
Referenced by diagonalcalc(), ReadDefFileIdxPara(), and setmem_def().
char* DefineList::CParaFileHead |
Read from Calcmod in readdef.h. It is not used. Just for the compatibility to mVMC.
Definition at line 44 of file struct.h.
Referenced by ReadDefFileNInt(), and setmem_HEAD().
double complex DefineList::dcOmegaMax |
Upper limit of the frequency for the spectrum.
Definition at line 209 of file struct.h.
Referenced by CalcSpectrum(), ReadDefFileNInt(), and SetOmega().
double complex DefineList::dcOmegaMin |
Lower limit of the frequency for the spectrum.
Definition at line 210 of file struct.h.
Referenced by CalcSpectrum(), ReadDefFileNInt(), and SetOmega().
double complex DefineList::dcOmegaOrg |
Origin limit of the frequency for the spectrum.
Definition at line 211 of file struct.h.
Referenced by CalcSpectrum(), and ReadDefFileNInt().
int* DefineList::EDChemi |
[DefineList::Nsite] Chemical potential. malloc in setmem_def().
Definition at line 98 of file struct.h.
Referenced by CheckTransferHermite(), diagonalcalc(), ReadDefFileIdxPara(), and setmem_def().
int** DefineList::EDGeneralTransfer |
Index of transfer integrals for calculation. malloc in setmem_def().
Data Format [DefineList::NTransfer][4]: 0->site number i, 1-> spin index on i, 2-> site number j, 3-> spin index on j.
Definition at line 110 of file struct.h.
Referenced by CheckTransferHermite(), child_general_hopp_MPIdouble(), child_general_hopp_MPIsingle(), GC_child_general_hopp_MPIdouble(), GC_child_general_hopp_MPIsingle(), HPhiTrans(), makeHam(), MakeTEDTransfer(), mltplyGeneralSpinGC(), mltplyHalfSpinGC(), mltplyHubbard(), mltplyHubbardGC(), setmem_def(), TransferForQuench(), and TransferWithPeierls().
unsigned int DefineList::EDNChemi |
Number of on-site term.
Definition at line 97 of file struct.h.
Referenced by CheckTransferHermite(), diagonalcalc(), ReadDefFileIdxPara(), and setmem_def().
unsigned int DefineList::EDNTransfer |
Number of transfer integrals for calculation.
Definition at line 105 of file struct.h.
Referenced by CalcByTEM(), CheckTransferHermite(), HPhiTrans(), makeHam(), MakeTEDTransfer(), mltplyGeneralSpinGC(), mltplyHalfSpinGC(), mltplyHubbard(), mltplyHubbardGC(), TransferForQuench(), and TransferWithPeierls().
double* DefineList::EDParaChemi |
[DefineList::Nsite] On-site potential parameter. malloc in setmem_def().
Definition at line 100 of file struct.h.
Referenced by CheckTransferHermite(), diagonalcalc(), ReadDefFileIdxPara(), and setmem_def().
double complex* DefineList::EDParaGeneralTransfer |
Value of general transfer integrals by a def file. malloc in setmem_def().
Data Format [DefineList::NTransfer].
Definition at line 116 of file struct.h.
Referenced by CheckTransferHermite(), child_general_hopp_MPIdouble(), child_general_hopp_MPIsingle(), GC_child_general_hopp_MPIdouble(), GC_child_general_hopp_MPIsingle(), makeHam(), MakeTEDTransfer(), mltplyGeneralSpinGC(), mltplyHalfSpinGC(), mltplyHubbard(), mltplyHubbardGC(), setmem_def(), TransferForQuench(), and TransferWithPeierls().
int* DefineList::EDSpinChemi |
Definition at line 99 of file struct.h.
Referenced by CheckTransferHermite(), diagonalcalc(), ReadDefFileIdxPara(), and setmem_def().
int** DefineList::ExchangeCoupling |
[DefineList::NExchangeCoupling][2] Index of exchange term. malloc in setmem_def().
Definition at line 146 of file struct.h.
Referenced by child_exchange_GetInfo(), child_exchange_spin_GetInfo(), mltplyHalfSpin(), mltplyHalfSpinGC(), mltplyHubbard(), mltplyHubbardGC(), ReadDefFileIdxPara(), and setmem_def().
int DefineList::fidx |
Always 0, it is not used ???
Definition at line 89 of file struct.h.
Referenced by ReadDefFileNInt().
int** DefineList::GeneralTransfer |
Index of transfer integrals obtained by a def file. malloc in setmem_def().
Data Format [DefineList::NTransfer][4]: 0->site number i, 1-> spin index on i, 2-> site number j, 3-> spin index on j.
Definition at line 106 of file struct.h.
Referenced by CheckSpinIndexForTrans(), CheckTransferHermite(), ReadDefFileIdxPara(), and setmem_def().
int** DefineList::HundCoupling |
[DefineList::NHundCoupling][2] Index of Hund coupling. malloc in setmem_def().
Definition at line 134 of file struct.h.
Referenced by diagonalcalc(), ReadDefFileIdxPara(), and setmem_def().
int DefineList::iCalcEigenVec |
Switch for method to calculate eigenvectors. 0:Lanczos+CG, 1: Lanczos. default value is set as 0 in readdef.c.
Definition at line 193 of file struct.h.
Referenced by CalcByLanczos(), and ReadcalcmodFile().
int DefineList::iCalcModel |
Switch for model. 0:Hubbard, 1:Spin, 2:Kondo, 3:HubbardGC, 4:SpinGC, 5:KondoGC, 6:HubbardNConserved.
Definition at line 198 of file struct.h.
Referenced by CalcByLanczos(), CalcByLOBPCG(), check(), CheckLocSpin(), CheckMPI(), CheckMPI_Summary(), child_omp_sz(), child_omp_sz_hacker(), expec_cisajs(), expec_cisajs_Hubbard(), expec_cisajscktaltdc(), expec_energy_flct(), expec_totalspin(), expec_totalSz(), GetlistSize(), GetPairExcitedState(), GetPairExcitedStateHubbard(), GetSingleExcitedState(), MakeExcitedList(), makeHam(), mltply(), output(), output_list(), OutputTimer(), phys(), Read_sz(), ReadcalcmodFile(), ReadDefFileIdxPara(), ReadDefFileNInt(), SetDiagonalChemi(), SetDiagonalCoulombInter(), SetDiagonalCoulombIntra(), SetDiagonalHund(), SetDiagonalInterAll(), SetDiagonalTEChemi(), SetDiagonalTEInterAll(), SetDiagonalTETransfer(), sz(), totalspin_Hubbard(), and totalspin_Spin().
int DefineList::iCalcType |
Switch for calculation type. 0:Lanczos, 1:TPQCalc, 2:FullDiag.
Definition at line 192 of file struct.h.
Referenced by CalcSpectrum(), check(), expec_cisajs(), expec_cisajscktaltdc(), expec_energy_flct(), main(), mltply(), output(), OutputTimer(), phys(), ReadcalcmodFile(), ReadDefFileNInt(), setmem_def(), setmem_large(), SetOmega(), and vec12().
int DefineList::iFlagListModified |
When the Hilbert space of excited state differs from the original one.
Definition at line 217 of file struct.h.
Referenced by CalcSpectrum(), and GetPairExcitedStateHubbard().
int DefineList::iFlgCalcSpec |
Input parameter CalcSpec in teh CalcMod file.
Definition at line 216 of file struct.h.
Referenced by CalcSpectrum(), CalcSpectrumByBiCG(), CalcSpectrumByTPQ(), check(), main(), OutputTimer(), ReadcalcmodFile(), ReadTMComponents_BiCG(), setmem_large(), sz(), and vec12().
int DefineList::iFlgFiniteTemperature |
int DefineList::iFlgGeneralSpin |
Flag for the general (Sz/=1/2) spin.
Definition at line 86 of file struct.h.
Referenced by CalcByLanczos(), CalcByLOBPCG(), check(), CheckLocSpin(), CheckMPI(), CheckMPI_Summary(), CheckSpinIndexForTrans(), CheckTotal2Sz(), expec_cisajs_Spin(), expec_cisajs_SpinGC(), expec_cisajscktalt_Spin(), expec_cisajscktalt_SpinGC(), expec_energy_flct(), GetlistSize(), GetPairExcitedState(), GetPairExcitedStateSpin(), GetPairExcitedStateSpinGC(), MakeExcitedList(), makeHam(), mltply(), mltplySpin(), mltplySpinGC(), ReadDefFileIdxPara(), ReadDefFileNInt(), SetDiagonalChemi(), SetDiagonalInterAll(), SetDiagonalTEChemi(), SetDiagonalTEInterAll(), SetDiagonalTETransfer(), sz(), totalspin_Spin(), totalspin_SpinGC(), and totalSz_SpinGC().
int DefineList::iFlgMPI |
MPI mode.
Definition at line 225 of file struct.h.
Referenced by ReadcalcmodFile(), and SetInitialVector().
int DefineList::iFlgScaLAPACK |
ScaLAPACK mode ( only for FullDiag )
Definition at line 235 of file struct.h.
Referenced by check(), CheckMPI_Summary(), main(), and ReadcalcmodFile().
int DefineList::iFlgSpecOmegaMax |
Whether DefineList::dcOmegaMax is input or not.
Definition at line 213 of file struct.h.
Referenced by ReadDefFileNInt(), and SetOmega().
int DefineList::iFlgSpecOmegaMin |
Whether DefineList::dcOmegaMin is input or not.
Definition at line 214 of file struct.h.
Referenced by ReadDefFileNInt(), and SetOmega().
int DefineList::iFlgSpecOmegaOrg |
Whether DefineList::dcOmegaOrg is input or not.
Definition at line 215 of file struct.h.
Referenced by CalcSpectrum(), and ReadDefFileNInt().
int DefineList::iFlgSzConserved |
Flag whether Sz is conserved.
Definition at line 87 of file struct.h.
Referenced by CheckTotal2Sz(), expec_cisajs_Hubbard(), expec_cisajscktalt_Hubbard(), and ReadDefFileNInt().
int DefineList::iInitialVecType |
Switch for type of inital vectors. 0:complex type, 1: real type. default value is set as 0 in readdef.c.
Definition at line 195 of file struct.h.
Referenced by Initialize_wave(), Lanczos_EigenVector(), ReadcalcmodFile(), and SetInitialVector().
int DefineList::iInputEigenVec |
Switch for reading an eigenvector. 0: no input, 1:input.
Definition at line 203 of file struct.h.
Referenced by CalcByLanczos(), CalcByLOBPCG(), CalcByTEM(), and ReadcalcmodFile().
int DefineList::iInputHam |
brief Switch for reading a Hamiltonian. 0: no input, 1:input
Definition at line 205 of file struct.h.
Referenced by CalcByFullDiag(), and ReadcalcmodFile().
int DefineList::iNGPU |
GPU mode ( only for FullDiag )
Definition at line 230 of file struct.h.
Referenced by lapack_diag(), and ReadcalcmodFile().
long int DefineList::initial_iv |
Seed of random number for initial guesss of wavefunctions.
Definition at line 76 of file struct.h.
Referenced by CalcByLanczos(), CalcByLOBPCG(), CG_EigenVector(), Initialize_wave(), InitShadowRes(), Lanczos_EigenVector(), ReadDefFileNInt(), and SetInitialVector().
int DefineList::iNOmega |
Number of frequencies for spectrum.
Definition at line 212 of file struct.h.
Referenced by CalcSpectrum(), and ReadDefFileNInt().
int** DefineList::InterAll |
[DefineList::NinterAll][8] Interacted quartet
Definition at line 160 of file struct.h.
Referenced by ReadDefFileIdxPara(), and setmem_def().
int** DefineList::InterAll_Diagonal |
[DefineList::NinterAll_Diagonal][4] Interacted quartet
Definition at line 162 of file struct.h.
Referenced by diagonalcalc(), ReadDefFileIdxPara(), and setmem_def().
int** DefineList::InterAll_OffDiagonal |
[DefineList::NinterAll_OffDiagonal][8] Interacted quartet
Definition at line 161 of file struct.h.
Referenced by child_general_int_GeneralSpin_MPIdouble(), child_general_int_GeneralSpin_MPIsingle(), child_general_int_spin_MPIdouble(), child_general_int_spin_MPIsingle(), GC_child_CisAisCjuAjv_spin_MPIdouble(), GC_child_CisAisCjuAjv_spin_MPIsingle(), GC_child_CisAitCiuAiv_spin_MPIdouble(), GC_child_CisAitCiuAiv_spin_MPIsingle(), GC_child_CisAitCjuAju_spin_MPIdouble(), GC_child_CisAitCjuAju_spin_MPIsingle(), GC_child_general_int_GeneralSpin_MPIdouble(), GC_child_general_int_GeneralSpin_MPIsingle(), GC_child_general_int_spin_MPIdouble(), GC_child_general_int_spin_MPIsingle(), makeHam(), MakeTEDInterAll(), mltplyGeneralSpin(), mltplyGeneralSpinGC(), mltplyHalfSpin(), mltplyHalfSpinGC(), mltplyHubbard(), mltplyHubbardGC(), ReadDefFileIdxPara(), and setmem_def().
int DefineList::iOutputEigenVec |
ASwitch for outputting an eigenvector. 0: no output, 1:output.
Definition at line 202 of file struct.h.
Referenced by CalcByLanczos(), CalcByLOBPCG(), CalcByTEM(), and ReadcalcmodFile().
int DefineList::iOutputExVec |
brief Switch for outputting an excited vector. 0: no output, 1:output
Definition at line 206 of file struct.h.
Referenced by CalcSpectrum(), and ReadcalcmodFile().
int DefineList::iOutputHam |
brief Switch for outputting a Hamiltonian. 0: no output, 1:output
Definition at line 204 of file struct.h.
Referenced by CalcByFullDiag(), and ReadcalcmodFile().
int DefineList::iOutputMode |
Switch for output mode. 0: OneBodyG and TwoBodyG. 1: OneBodyG and TwoBodyG and correlations for charge and spin.
Definition at line 200 of file struct.h.
Referenced by ReadcalcmodFile().
int DefineList::irand |
Input keyword TargetTPQRand ???
Definition at line 79 of file struct.h.
Referenced by CalcByTPQ(), expec_cisajs(), expec_cisajscktaltdc(), and ReadDefFileNInt().
int DefineList::iReStart |
An integer for restarting output a Hamiltonian.
Definition at line 221 of file struct.h.
Referenced by CalcByTEM(), CalcByTPQ(), Initialize_wave(), Lanczos_EigenValue(), LOBPCG_Main(), and ReadcalcmodFile().
int DefineList::istep |
Index of TPQ step ???
Definition at line 78 of file struct.h.
Referenced by CalcByTEM(), CalcByTPQ(), expec_cisajs(), and expec_cisajscktaltdc().
unsigned int DefineList::k_exct |
Read from Calcmod in readdef.h.
Definition at line 47 of file struct.h.
Referenced by CalcByLanczos(), CalcByLOBPCG(), check(), Initialize_wave(), Lanczos_EigenValue(), Lanczos_EigenVector(), LOBPCG_Main(), main(), Output_restart(), ReadDefFileNInt(), SetInitialVector(), and setmem_large().
unsigned int DefineList::Lanczos_max |
Maximum number of iterations.
Definition at line 74 of file struct.h.
Referenced by CalcByTEM(), CalcByTPQ(), CalcSpectrumByBiCG(), CalcSpectrumByTPQ(), Lanczos_EigenValue(), LOBPCG_Main(), ReadDefFileNInt(), ReadTMComponents(), ReadTMComponents_BiCG(), and setmem_large().
int DefineList::Lanczos_restart |
Number of iterations performed in the restart computation.
Definition at line 75 of file struct.h.
Referenced by CalcSpectrumByTPQ(), Lanczos_EigenValue(), and Lanczos_GetTridiagonalMatrixComponents().
int DefineList::LanczosEps |
log(10 base) of the convergence threshold. Read from Calcmod in readdef.h
Definition at line 48 of file struct.h.
Referenced by LOBPCG_Main(), ReadDefFileNInt(), and SetConvergenceFactor().
int DefineList::LanczosTarget |
Which eigenstate is used to check convergence. Read from Calcmod in readdef.h.
Definition at line 50 of file struct.h.
Referenced by Lanczos_EigenValue(), ReadDefFileNInt(), ReadTMComponents(), setmem_large(), and vec12().
int* DefineList::LocSpn |
[DefineList::NLocSpn] Flag (and size) of the local spin. malloc in setmem_def().
Definition at line 82 of file struct.h.
Referenced by CheckLocSpin(), CheckMPI(), CheckSpinIndexForTrans(), child_omp_sz_Kondo(), child_omp_sz_Kondo_hacker(), child_omp_sz_KondoGC(), expec_cisajs_Hubbard(), ReadDefFileIdxPara(), setmem_def(), and sz().
unsigned int DefineList::NCisAjt |
Number of indices of two-body correlation function.
Definition at line 175 of file struct.h.
Referenced by expec_cisajs(), expec_cisajs_Hubbard(), expec_cisajs_HubbardGC(), expec_cisajs_SpinGCGeneral(), expec_cisajs_SpinGCHalf(), expec_cisajs_SpinGeneral(), expec_cisajs_SpinHalf(), InitializeInteractionNum(), ReadDefFileIdxPara(), ReadDefFileNInt(), and setmem_def().
unsigned int DefineList::NCisAjtCkuAlvDC |
Number of indices of two-body correlation function.
Definition at line 178 of file struct.h.
Referenced by expec_cisajscktalt_Hubbard(), expec_cisajscktalt_HubbardGC(), expec_cisajscktalt_SpinGCGeneral(), expec_cisajscktalt_SpinGCHalf(), expec_cisajscktalt_SpinGeneral(), expec_cisajscktalt_SpinHalf(), expec_cisajscktaltdc(), InitializeInteractionNum(), ReadDefFileIdxPara(), ReadDefFileNInt(), and setmem_def().
unsigned int DefineList::NCond |
Number of itinerant electrons.
Definition at line 85 of file struct.h.
Referenced by CheckTotal2Sz(), and ReadDefFileNInt().
unsigned int DefineList::NCoulombInter |
Number of off-site Coulomb interaction.
Definition at line 127 of file struct.h.
Referenced by diagonalcalc(), InitializeInteractionNum(), ReadDefFileIdxPara(), ReadDefFileNInt(), ResetInteractionNum(), and setmem_def().
unsigned int DefineList::NCoulombIntra |
Number of on-site Coulomb interaction
Definition at line 121 of file struct.h.
Referenced by diagonalcalc(), InitializeInteractionNum(), ReadDefFileIdxPara(), ReadDefFileNInt(), and setmem_def().
unsigned int DefineList::Ndown |
Number of spin-down electrons in this process.
Definition at line 59 of file struct.h.
Referenced by check(), CheckMPI(), CheckMPI_Summary(), CheckTotal2Sz(), child_omp_sz(), child_omp_sz_hacker(), child_omp_sz_Kondo(), child_omp_sz_Kondo_hacker(), MakeExcitedList(), output(), output_list(), Read_sz(), ReadDefFileNInt(), and sz().
unsigned int DefineList::NdownMPI |
Total number of spin-down electrons across processes. Deffer from DefineList::Ndown. Read from modpara in readdef.h.
Definition at line 62 of file struct.h.
Referenced by ReadDefFileNInt().
unsigned int DefineList::NdownOrg |
Number of spin-down electrons before exitation. Used only in the spectrum calculation. Read from modpara in readdef.h.
Definition at line 66 of file struct.h.
Referenced by MakeExcitedList(), and ReadDefFileNInt().
unsigned int DefineList::Ne |
Number of electrons in this process.
Definition at line 71 of file struct.h.
Referenced by check(), CheckMPI(), CheckMPI_Summary(), child_omp_sz(), child_omp_sz_hacker(), child_omp_sz_spin(), child_omp_sz_spin_hacker(), MakeExcitedList(), output_list(), Read_sz(), ReadDefFileNInt(), and sz().
unsigned int DefineList::NeMPI |
Total number of electrons across process. Differ from DefineList::Ne .
Definition at line 72 of file struct.h.
Referenced by MakeExcitedList(), and ReadDefFileNInt().
unsigned int DefineList::NExchangeCoupling |
Number of exchange term.
Definition at line 145 of file struct.h.
Referenced by makeHam(), mltplyHalfSpin(), mltplyHalfSpinGC(), mltplyHubbard(), mltplyHubbardGC(), ReadDefFileIdxPara(), ReadDefFileNInt(), and setmem_def().
unsigned int DefineList::NHundCoupling |
Number of Hund coupling.
Definition at line 133 of file struct.h.
Referenced by diagonalcalc(), ReadDefFileIdxPara(), ReadDefFileNInt(), ResetInteractionNum(), and setmem_def().
unsigned int DefineList::NInterAll |
Total Number of Interacted quartet.
Definition at line 163 of file struct.h.
Referenced by InitializeInteractionNum(), ReadDefFileIdxPara(), ReadDefFileNInt(), and setmem_def().
unsigned int DefineList::NInterAll_Diagonal |
Number of interall term (diagonal)
Definition at line 164 of file struct.h.
Referenced by diagonalcalc(), and ReadDefFileIdxPara().
unsigned int DefineList::NInterAll_OffDiagonal |
Number of interall term (off-diagonal)
Definition at line 165 of file struct.h.
Referenced by CalcByTEM(), makeHam(), MakeTEDInterAll(), mltplyGeneralSpin(), mltplyGeneralSpinGC(), mltplyHalfSpin(), mltplyHalfSpinGC(), mltplyHubbard(), mltplyHubbardGC(), and ReadDefFileIdxPara().
unsigned int DefineList::NIsingCoupling |
Number of Ising term.
Definition at line 151 of file struct.h.
Referenced by InitializeInteractionNum(), ReadDefFileIdxPara(), ReadDefFileNInt(), ResetInteractionNum(), and setmem_def().
unsigned int DefineList::NLaser |
Definition at line 250 of file struct.h.
Referenced by CalcByTEM(), InitializeInteractionNum(), ReadDefFileIdxPara(), ReadDefFileNInt(), and setmem_def().
unsigned int DefineList::NLocSpn |
Number of local spins.
Definition at line 84 of file struct.h.
Referenced by check(), CheckMPI(), CheckTotal2Sz(), ReadDefFileNInt(), and sz().
unsigned int DefineList::NPairExcitationOperator |
Number of pair excitaion operator for spectrum.
Definition at line 188 of file struct.h.
Referenced by CalcSpectrum(), GetExcitedState(), GetPairExcitedStateGeneralSpin(), GetPairExcitedStateGeneralSpinGC(), GetPairExcitedStateHalfSpin(), GetPairExcitedStateHalfSpinGC(), GetPairExcitedStateHubbard(), GetPairExcitedStateHubbardGC(), InitializeInteractionNum(), MakeExcitedList(), ReadDefFileIdxPara(), ReadDefFileNInt(), and setmem_def().
unsigned int DefineList::NPairHopping |
Number of pair-hopping term.
Definition at line 139 of file struct.h.
Referenced by makeHam(), mltplyHubbard(), mltplyHubbardGC(), ReadDefFileIdxPara(), ReadDefFileNInt(), and setmem_def().
unsigned int DefineList::NPairLiftCoupling |
Number of pair-lift term.
Definition at line 153 of file struct.h.
Referenced by InitializeInteractionNum(), makeHam(), mltplyHalfSpinGC(), ReadDefFileIdxPara(), ReadDefFileNInt(), and setmem_def().
unsigned int DefineList::NSingleExcitationOperator |
Number of single excitaion operator for spectrum.
Definition at line 182 of file struct.h.
Referenced by CalcSpectrum(), GetExcitedState(), GetSingleExcitedState(), GetSingleExcitedStateHubbard(), GetSingleExcitedStateHubbardGC(), InitializeInteractionNum(), MakeExcitedList(), ReadDefFileIdxPara(), ReadDefFileNInt(), and setmem_def().
unsigned int DefineList::Nsite |
Number of sites in the INTRA process region.
Definition at line 56 of file struct.h.
Referenced by CalcSpectrumByTPQ(), check(), CheckLocSpin(), CheckMPI(), CheckMPI_Summary(), CheckPE(), child_omp_sz(), child_omp_sz_hacker(), child_omp_sz_Kondo(), child_omp_sz_Kondo_hacker(), child_omp_sz_KondoGC(), child_omp_sz_spin_hacker(), expec_cisajs(), expec_cisajs_Hubbard(), expec_cisajs_HubbardGC(), expec_cisajs_SpinGCGeneral(), expec_cisajs_SpinGCHalf(), expec_cisajs_SpinGeneral(), expec_cisajs_SpinHalf(), expec_cisajscktalt_SpinGCGeneral(), expec_cisajscktalt_SpinGCHalf(), expec_cisajscktalt_SpinGeneral(), expec_cisajscktalt_SpinHalf(), expec_cisajscktaltdc(), expec_energy_flct(), expec_energy_flct_GeneralSpin(), expec_energy_flct_GeneralSpinGC(), expec_energy_flct_HalfSpin(), expec_energy_flct_HalfSpinGC(), expec_energy_flct_Hubbard(), expec_energy_flct_HubbardGC(), GetlistSize(), GetPairExcitedState(), GetPairExcitedStateGeneralSpin(), GetPairExcitedStateGeneralSpinGC(), GetPairExcitedStateHalfSpin(), GetPairExcitedStateHalfSpinGC(), GetPairExcitedStateHubbard(), GetPairExcitedStateHubbardGC(), GetSgnInterAll(), GetSingleExcitedStateHubbard(), GetSingleExcitedStateHubbardGC(), MakeExcitedList(), makeHam(), mltply(), mltplyGeneralSpin(), mltplyGeneralSpinGC(), mltplyHalfSpin(), mltplyHalfSpinGC(), mltplyHubbard(), mltplyHubbardGC(), output_list(), Read_sz(), ReadDefFileIdxPara(), ReadDefFileNInt(), SetDiagonalChemi(), SetDiagonalCoulombInter(), SetDiagonalCoulombIntra(), SetDiagonalHund(), SetDiagonalInterAll(), SetDiagonalTEChemi(), SetDiagonalTEInterAll(), SetDiagonalTETransfer(), setmem_def(), SetOmega(), sz(), totalspin_Hubbard(), totalspin_Spin(), totalspin_SpinGC(), totalSz_HubbardGC(), totalSz_SpinGC(), X_child_CisAis_Hubbard_MPI(), X_child_CisAisCjtAjt_Hubbard_MPI(), X_child_CisAjt_MPIsingle(), X_child_CisAjtCkuAku_Hubbard_MPI(), X_child_CisAjtCkuAlv_Hubbard_MPI(), X_child_general_hopp_MPIsingle(), X_GC_child_CisAis_Hubbard_MPI(), X_GC_child_CisAisCjtAjt_Hubbard_MPI(), X_GC_child_CisAjt_Hubbard_MPI(), X_GC_child_CisAjtCkuAku_Hubbard_MPI(), X_GC_child_CisAjtCkuAlv_Hubbard_MPI(), and X_GC_child_general_hopp_MPIsingle().
unsigned int DefineList::NsiteMPI |
Total number of sites, differ from DefineList::Nsite.
Definition at line 57 of file struct.h.
Referenced by CalcByTPQ(), check(), CheckMPI(), CheckMPI_Summary(), expec_energy_flct(), expec_energy_flct_GeneralSpin(), expec_energy_flct_GeneralSpinGC(), expec_energy_flct_HalfSpin(), expec_energy_flct_HalfSpinGC(), expec_energy_flct_Hubbard(), expec_energy_flct_HubbardGC(), Lanczos_EigenValue(), MakeExcitedList(), Multiply(), phys(), totalspin_Hubbard(), totalspin_HubbardGC(), totalspin_Spin(), totalspin_SpinGC(), totalSz_HubbardGC(), and totalSz_SpinGC().
unsigned int* DefineList::NTEChemi |
[NTE]
Definition at line 294 of file struct.h.
Referenced by diagonalcalcForTE(), ReadDefFileIdxPara(), and setmem_def().
unsigned int* DefineList::NTEInterAll |
Number of time-dependent InterAll for Time Evolution.
Data Format [NTE]
Definition at line 271 of file struct.h.
Referenced by InitializeInteractionNum(), ReadDefFileIdxPara(), and setmem_def().
unsigned int* DefineList::NTEInterAllDiagonal |
Number of diagonal part of time-dependent InterAll for Time Evolution.
Data Format [NTE]
Definition at line 276 of file struct.h.
Referenced by diagonalcalcForTE(), ReadDefFileIdxPara(), and setmem_def().
unsigned int DefineList::NTEInterAllMax |
Definition at line 270 of file struct.h.
Referenced by CalcByTEM(), MakeTEDInterAll(), ReadDefFileNInt(), and setmem_def().
unsigned int* DefineList::NTEInterAllOffDiagonal |
Number of off-diagonal part of time-dependent InterAll for Time Evolution.
Data Format [NTE]
Definition at line 273 of file struct.h.
Referenced by MakeTEDInterAll(), ReadDefFileIdxPara(), and setmem_def().
unsigned int DefineList::NTETimeSteps |
Definition at line 246 of file struct.h.
Referenced by CalcByTEM(), InitializeInteractionNum(), ReadDefFileIdxPara(), ReadDefFileNInt(), and setmem_def().
unsigned int* DefineList::NTETransfer |
Number of time-dependent transfer integrals for Time Evolution.
Data Format [NTE]
Definition at line 256 of file struct.h.
Referenced by CheckTETransferHermite(), InitializeInteractionNum(), MakeTEDTransfer(), ReadDefFileIdxPara(), and setmem_def().
unsigned int* DefineList::NTETransferDiagonal |
Number of time-dependent transfer integrals for Time Evolution.
Data Format [NTE]
Definition at line 258 of file struct.h.
Referenced by CheckTETransferHermite(), diagonalcalcForTE(), and setmem_def().
unsigned int DefineList::NTETransferMax |
Definition at line 255 of file struct.h.
Referenced by CalcByTEM(), MakeTEDTransfer(), ReadDefFileNInt(), and setmem_def().
unsigned int DefineList::NTransfer |
Number of transfer integrals obtained by a def file.
Definition at line 104 of file struct.h.
Referenced by CheckSpinIndexForTrans(), CheckTransferHermite(), InitializeInteractionNum(), ReadDefFileIdxPara(), ReadDefFileNInt(), and setmem_def().
unsigned int DefineList::Nup |
Number of spin-up electrons in this process.
Definition at line 58 of file struct.h.
Referenced by check(), CheckMPI(), CheckMPI_Summary(), CheckTotal2Sz(), child_omp_sz(), child_omp_sz_hacker(), child_omp_sz_Kondo(), child_omp_sz_Kondo_hacker(), MakeExcitedList(), output(), output_list(), Read_sz(), ReadDefFileNInt(), and sz().
unsigned int DefineList::NupMPI |
Total number of spin-up electrons across processes. Deffer from DefineList::Nup. Read from modpara in readdef.h.
Definition at line 60 of file struct.h.
Referenced by ReadDefFileNInt().
unsigned int DefineList::NupOrg |
Number of spin-up electrons before exitation. Used only in the spectrum calculation. Read from modpara in readdef.h.
Definition at line 64 of file struct.h.
Referenced by MakeExcitedList(), and ReadDefFileNInt().
unsigned int DefineList::nvec |
Read from Calcmod in readdef.h.
Definition at line 46 of file struct.h.
Referenced by CalcSpectrumByTPQ(), main(), ReadDefFileNInt(), ReadTMComponents(), setmem_large(), and vec12().
long unsigned int* DefineList::OrgTpow |
[2 * DefineList::NsiteMPI] \(2^n\) malloc in setmem_def().
Definition at line 92 of file struct.h.
Referenced by CheckMPI_Summary(), expec_cisajscktalt_Hubbard(), expec_cisajscktalt_HubbardGC(), GetPairExcitedStateHubbard(), GetSgnInterAll(), MakeExcitedList(), mltplyHubbard(), mltplyHubbardGC(), setmem_def(), X_child_CisAjtCkuAku_Hubbard_MPI(), X_child_CisAjtCkuAlv_Hubbard_MPI(), X_GC_child_CisAjtCkuAku_Hubbard_MPI(), and X_GC_child_CisAjtCkuAlv_Hubbard_MPI().
int** DefineList::PairExcitationOperator |
[DefineList::NPairExcitationOperator][5] Indices of pair excitaion operator for spectrum. malloc in setmem_def().
Definition at line 186 of file struct.h.
Referenced by GetPairExcitedStateGeneralSpin(), GetPairExcitedStateGeneralSpinGC(), GetPairExcitedStateHalfSpin(), GetPairExcitedStateHalfSpinGC(), GetPairExcitedStateHubbard(), GetPairExcitedStateHubbardGC(), MakeExcitedList(), ReadDefFileIdxPara(), and setmem_def().
int** DefineList::PairHopping |
[DefineList::NPairHopping][2] Index of pair-hopping. malloc in setmem_def().
Definition at line 140 of file struct.h.
Referenced by child_pairhopp_GetInfo(), mltplyHubbard(), mltplyHubbardGC(), ReadDefFileIdxPara(), and setmem_def().
int** DefineList::PairLiftCoupling |
[DefineList::NPairHopping][2] Index of pair-lift term. malloc in setmem_def().
Definition at line 154 of file struct.h.
Referenced by child_pairlift_spin_GetInfo(), mltplyHalfSpinGC(), ReadDefFileIdxPara(), and setmem_def().
double* DefineList::ParaCoulombInter |
[DefineList::NCoulombInter]Coupling constant of off-site Coulomb interaction. malloc in setmem_def().
Definition at line 130 of file struct.h.
Referenced by diagonalcalc(), ReadDefFileIdxPara(), and setmem_def().
double* DefineList::ParaCoulombIntra |
[DefineList::NCoulombIntra] Coupling constant of on-site Coulomb interaction. malloc in setmem_def().
Definition at line 124 of file struct.h.
Referenced by diagonalcalc(), ReadDefFileIdxPara(), and setmem_def().
double* DefineList::ParaExchangeCoupling |
[DefineList::NExchangeCoupling] Coupling constant of exchange term. malloc in setmem_def().
Definition at line 148 of file struct.h.
Referenced by child_exchange_GetInfo(), child_exchange_spin_GetInfo(), mltplyHalfSpin(), mltplyHalfSpinGC(), mltplyHubbard(), mltplyHubbardGC(), ReadDefFileIdxPara(), and setmem_def().
double complex* DefineList::ParaGeneralTransfer |
Value of general transfer integrals by a def file. malloc in setmem_def().
Data Format [DefineList::NTransfer].
Definition at line 113 of file struct.h.
Referenced by CheckTransferHermite(), ReadDefFileIdxPara(), setmem_def(), TransferForQuench(), and TransferWithPeierls().
double* DefineList::ParaHundCoupling |
[DefineList::NHundCoupling] Hund coupling constant. malloc in setmem_def().
Definition at line 136 of file struct.h.
Referenced by diagonalcalc(), ReadDefFileIdxPara(), and setmem_def().
double complex* DefineList::ParaInterAll |
[DefineList::NInterAll] Coupling constant of inter-all term. malloc in setmem_def().
Definition at line 166 of file struct.h.
Referenced by ReadDefFileIdxPara(), and setmem_def().
double* DefineList::ParaInterAll_Diagonal |
[DefineList::NInterAll_Diagonal] Coupling constant of diagonal inter-all term. malloc in setmem_def().
Definition at line 168 of file struct.h.
Referenced by diagonalcalc(), ReadDefFileIdxPara(), and setmem_def().
double complex* DefineList::ParaInterAll_OffDiagonal |
[DefineList::NInterAll_OffDiagonal] Coupling constant of off-diagonal inter-all term. malloc in setmem_def().
Definition at line 170 of file struct.h.
Referenced by child_general_int_GeneralSpin_MPIdouble(), child_general_int_GeneralSpin_MPIsingle(), child_general_int_spin_MPIdouble(), child_general_int_spin_MPIsingle(), GC_child_CisAisCjuAjv_spin_MPIdouble(), GC_child_CisAisCjuAjv_spin_MPIsingle(), GC_child_CisAitCiuAiv_spin_MPIdouble(), GC_child_CisAitCiuAiv_spin_MPIsingle(), GC_child_CisAitCjuAju_spin_MPIdouble(), GC_child_CisAitCjuAju_spin_MPIsingle(), GC_child_general_int_GeneralSpin_MPIdouble(), GC_child_general_int_GeneralSpin_MPIsingle(), makeHam(), MakeTEDInterAll(), mltplyGeneralSpin(), mltplyGeneralSpinGC(), mltplyHalfSpin(), mltplyHalfSpinGC(), mltplyHubbard(), mltplyHubbardGC(), ReadDefFileIdxPara(), and setmem_def().
double* DefineList::ParaLaser |
Definition at line 251 of file struct.h.
Referenced by ReadDefFileIdxPara(), setmem_def(), TransferForQuench(), and TransferWithPeierls().
struct ParamList DefineList::Param |
Definition at line 241 of file struct.h.
Referenced by CalcByTEM(), main(), MultiplyForTEM(), and ReadDefFileNInt().
double complex* DefineList::ParaPairExcitationOperator |
[DefineList::NPairExcitationOperator] Coefficient of pair excitaion operator for spectrum. malloc in setmem_def().
Definition at line 189 of file struct.h.
Referenced by GetPairExcitedStateGeneralSpin(), GetPairExcitedStateGeneralSpinGC(), GetPairExcitedStateHalfSpin(), GetPairExcitedStateHalfSpinGC(), GetPairExcitedStateHubbard(), GetPairExcitedStateHubbardGC(), ReadDefFileIdxPara(), and setmem_def().
double* DefineList::ParaPairHopping |
[DefineList::NPairHopping] Coupling constant of pair-hopping term. malloc in setmem_def().
Definition at line 142 of file struct.h.
Referenced by child_pairhopp_GetInfo(), mltplyHubbard(), mltplyHubbardGC(), ReadDefFileIdxPara(), and setmem_def().
double* DefineList::ParaPairLiftCoupling |
[DefineList::NPairHopping] Coupling constant of pair-lift term. malloc in setmem_def().
Definition at line 156 of file struct.h.
Referenced by child_pairlift_spin_GetInfo(), mltplyHalfSpinGC(), ReadDefFileIdxPara(), and setmem_def().
double complex* DefineList::ParaSingleExcitationOperator |
[DefineList::NSingleExcitationOperator] Coefficient of single excitaion operator for spectrum. malloc in setmem_def().
Definition at line 183 of file struct.h.
Referenced by GetSingleExcitedStateHubbard(), GetSingleExcitedStateHubbardGC(), ReadDefFileIdxPara(), and setmem_def().
double** DefineList::ParaTEChemi |
[NTE][Nsite]
Definition at line 296 of file struct.h.
Referenced by diagonalcalcForTE(), ReadDefFileIdxPara(), and setmem_def().
double complex** DefineList::ParaTEInterAll |
Value of time-dependent InterAll for Time Evolution.
Data Format [NTE][Ntransfer].
Definition at line 286 of file struct.h.
Referenced by ReadDefFileIdxPara(), and setmem_def().
double** DefineList::ParaTEInterAllDiagonal |
Value of diagonal part of time-dependent InterAll for Time Evolution.
Data Format [NTE][Ntransfer].
Definition at line 291 of file struct.h.
Referenced by diagonalcalcForTE(), ReadDefFileIdxPara(), and setmem_def().
double complex** DefineList::ParaTEInterAllOffDiagonal |
Value of off-diagonal part of time-dependent InterAll for Time Evolution.
Data Format [NTE][Ntransfer].
Definition at line 288 of file struct.h.
Referenced by MakeTEDInterAll(), ReadDefFileIdxPara(), and setmem_def().
double complex** DefineList::ParaTETransfer |
Value of time-dependent transfer integrals for Time Evolution.
Data Format [NTE][Ntransfer].
Definition at line 264 of file struct.h.
Referenced by CheckTETransferHermite(), MakeTEDTransfer(), ReadDefFileIdxPara(), and setmem_def().
double** DefineList::ParaTETransferDiagonal |
Value of time-dependent transfer integrals for Time Evolution.
Data Format [NTE][Ntransfer].
Definition at line 266 of file struct.h.
Referenced by CheckTETransferHermite(), diagonalcalcForTE(), and setmem_def().
int DefineList::READ |
It is ALWAYS 0 ???
Definition at line 53 of file struct.h.
Referenced by ReadDefFileNInt(), and sz().
int DefineList::read_hacker |
Whether use an efficient method (=1) in sz.c or not (=0)
Definition at line 52 of file struct.h.
Referenced by ReadDefFileNInt(), and sz().
int** DefineList::SingleExcitationOperator |
[DefineList::NSingleExcitationOperator][3] Indices of single excitaion operator for spectrum. malloc in setmem_def().
Definition at line 180 of file struct.h.
Referenced by GetSingleExcitedStateHubbard(), GetSingleExcitedStateHubbardGC(), MakeExcitedList(), ReadDefFileIdxPara(), and setmem_def().
long int* DefineList::SiteToBit |
[DefineList::NsiteMPI] Similar to DefineList::Tpow. For general spin.
Definition at line 94 of file struct.h.
Referenced by check(), CheckMPI(), CheckMPI_Summary(), expec_cisajs_SpinGCGeneral(), expec_cisajs_SpinGeneral(), expec_cisajscktalt_SpinGCGeneral(), expec_cisajscktalt_SpinGeneral(), expec_energy_flct_GeneralSpin(), expec_energy_flct_GeneralSpinGC(), GetlistSize(), GetPairExcitedState(), GetPairExcitedStateGeneralSpin(), GetPairExcitedStateGeneralSpinGC(), makeHam(), mltply(), mltplyGeneralSpin(), mltplyGeneralSpinGC(), ReadDefFileIdxPara(), SetDiagonalChemi(), SetDiagonalInterAll(), SetDiagonalTEChemi(), SetDiagonalTEInterAll(), SetDiagonalTETransfer(), setmem_def(), sz(), totalspin_Spin(), totalspin_SpinGC(), totalSz_SpinGC(), X_child_CisAisCjuAju_GeneralSpin_MPIdouble(), X_child_CisAisCjuAju_GeneralSpin_MPIsingle(), X_child_CisAit_GeneralSpin_MPIdouble(), X_child_CisAitCjuAjv_GeneralSpin_MPIdouble(), X_child_CisAitCjuAjv_GeneralSpin_MPIsingle(), X_GC_child_AisCis_GeneralSpin_MPIdouble(), X_GC_child_CisAis_GeneralSpin_MPIdouble(), X_GC_child_CisAisCjuAju_GeneralSpin_MPIdouble(), X_GC_child_CisAisCjuAju_GeneralSpin_MPIsingle(), X_GC_child_CisAisCjuAjv_GeneralSpin_MPIdouble(), X_GC_child_CisAisCjuAjv_GeneralSpin_MPIsingle(), X_GC_child_CisAit_GeneralSpin_MPIdouble(), X_GC_child_CisAitCjuAju_GeneralSpin_MPIdouble(), X_GC_child_CisAitCjuAju_GeneralSpin_MPIsingle(), X_GC_child_CisAitCjuAjv_GeneralSpin_MPIdouble(), and X_GC_child_CisAitCjuAjv_GeneralSpin_MPIsingle().
int** DefineList::SpinTEChemi |
[NTE][Nsite]
Definition at line 295 of file struct.h.
Referenced by diagonalcalcForTE(), ReadDefFileIdxPara(), and setmem_def().
int DefineList::St |
0 or 1, but it affects nothing.
Definition at line 80 of file struct.h.
Referenced by CalcByFullDiag(), CalcByLanczos(), CalcByLOBPCG(), CalcByTEM(), CalcByTPQ(), expec_cisajs(), and expec_cisajscktaltdc().
int** DefineList::TEChemi |
[NTE][Nsite]
Definition at line 293 of file struct.h.
Referenced by diagonalcalcForTE(), ReadDefFileIdxPara(), and setmem_def().
int*** DefineList::TEInterAll |
Index of time-dependent InterAll for Time Evolution.
Data Format [NTE][NTEInterAll][8]: 0->site number i, 1-> spin index on i, 2-> site number j, 3-> spin index on j. 4->site number k, 5-> spin index on k, 6-> site number l, 7-> spin index on l.
Definition at line 278 of file struct.h.
Referenced by ReadDefFileIdxPara(), and setmem_def().
int*** DefineList::TEInterAllDiagonal |
Index of diagonal part of time-dependent InterAll for Time Evolution.
Data Format [NTE][NTEInterAll][4]: 0->site number i, 1-> spin index on i, 2-> site number j, 3-> spin index on j.
Definition at line 284 of file struct.h.
Referenced by diagonalcalcForTE(), ReadDefFileIdxPara(), and setmem_def().
int*** DefineList::TEInterAllOffDiagonal |
Index of off-diagonal part of time-dependent InterAll for Time Evolution.
Data Format [NTE][NTEInterAll][8]: 0->site number i, 1-> spin index on i, 2-> site number j, 3-> spin index on j. 4->site number k, 5-> spin index on k, 6-> site number l, 7-> spin index on l.
Definition at line 281 of file struct.h.
Referenced by MakeTEDInterAll(), ReadDefFileIdxPara(), and setmem_def().
double* DefineList::TETime |
Definition at line 247 of file struct.h.
Referenced by CalcByTEM(), ReadDefFileIdxPara(), and setmem_def().
int*** DefineList::TETransfer |
Index of time-dependent transfer integrals for Time Evolution.
Data Format [NTE][Ntransfer][4]: 0->site number i, 1-> spin index on i, 2-> site number j, 3-> spin index on j.
Definition at line 260 of file struct.h.
Referenced by CheckTETransferHermite(), MakeTEDTransfer(), ReadDefFileIdxPara(), and setmem_def().
int*** DefineList::TETransferDiagonal |
Index of time-dependent transfer integrals for Time Evolution.
Data Format [NTE][Ntransfer][2]: 0->site number i, 1-> spin index on i.
Definition at line 262 of file struct.h.
Referenced by CheckTETransferHermite(), diagonalcalcForTE(), and setmem_def().
int DefineList::Total2Sz |
Total \(2S_z\) in this process.
Definition at line 69 of file struct.h.
Referenced by check(), CheckMPI(), CheckMPI_Summary(), CheckTotal2Sz(), child_omp_sz_GeneralSpin(), MakeExcitedList(), ReadDefFileNInt(), and sz().
int DefineList::Total2SzMPI |
Total \(2S_z\) across processes.
Definition at line 70 of file struct.h.
Referenced by check(), CheckMPI(), expec_energy_flct(), expec_totalspin(), expec_totalSz(), and MakeExcitedList().
long unsigned int* DefineList::Tpow |
[2 * DefineList::NsiteMPI] \(2^n\) malloc in setmem_def().
Definition at line 90 of file struct.h.
Referenced by check(), CheckBit_InterAllPE(), CheckBit_PairPE(), CheckMPI_Summary(), child_exchange_GetInfo(), child_exchange_spin_GetInfo(), child_general_hopp_GetInfo(), child_general_int_GetInfo(), child_general_int_spin_GetInfo(), child_omp_sz(), child_omp_sz_hacker(), child_omp_sz_Kondo(), child_omp_sz_Kondo_hacker(), child_omp_sz_KondoGC(), child_omp_sz_spin(), child_omp_sz_spin_hacker(), child_pairhopp_GetInfo(), child_pairlift_spin_GetInfo(), expec_cisajs_Hubbard(), expec_cisajs_HubbardGC(), expec_cisajs_SpinGCGeneral(), expec_cisajs_SpinGCHalf(), expec_cisajs_SpinGeneral(), expec_cisajs_SpinHalf(), expec_cisajscktalt_SpinGCGeneral(), expec_cisajscktalt_SpinGCHalf(), expec_cisajscktalt_SpinGeneral(), expec_cisajscktalt_SpinHalf(), expec_energy_flct_GeneralSpin(), expec_energy_flct_GeneralSpinGC(), expec_energy_flct_HalfSpin(), expec_energy_flct_HalfSpinGC(), expec_energy_flct_Hubbard(), expec_energy_flct_HubbardGC(), GC_child_general_int_spin(), GetlistSize(), GetPairExcitedStateGeneralSpin(), GetPairExcitedStateGeneralSpinGC(), GetPairExcitedStateHalfSpin(), GetPairExcitedStateHalfSpinGC(), GetPairExcitedStateHubbard(), GetPairExcitedStateHubbardGC(), GetSingleExcitedStateHubbard(), GetSingleExcitedStateHubbardGC(), makeHam(), mltplyGeneralSpin(), mltplyGeneralSpinGC(), mltplyHalfSpinGC(), SetDiagonalChemi(), SetDiagonalCoulombInter(), SetDiagonalCoulombIntra(), SetDiagonalHund(), SetDiagonalInterAll(), SetDiagonalTEChemi(), SetDiagonalTEInterAll(), SetDiagonalTETransfer(), setmem_def(), sz(), totalspin_Hubbard(), totalspin_HubbardGC(), totalspin_Spin(), totalspin_SpinGC(), totalSz_HubbardGC(), totalSz_SpinGC(), X_child_CisAis_Hubbard_MPI(), X_child_CisAisCjtAjt_Hubbard_MPI(), X_child_CisAisCjuAju_GeneralSpin_MPIdouble(), X_child_CisAisCjuAju_GeneralSpin_MPIsingle(), X_child_CisAit_GeneralSpin_MPIdouble(), X_child_CisAit_spin_MPIdouble(), X_child_CisAitCjuAjv_GeneralSpin_MPIdouble(), X_child_CisAitCjuAjv_GeneralSpin_MPIsingle(), X_child_CisAjt_MPIdouble(), X_child_CisAjt_MPIsingle(), X_child_CisAjtCkuAku_Hubbard_MPI(), X_child_CisAjtCkuAlv_Hubbard_MPI(), X_child_general_hopp_MPIdouble(), X_child_general_hopp_MPIsingle(), X_child_general_int_spin_MPIdouble(), X_child_general_int_spin_MPIsingle(), X_child_general_int_spin_TotalS_MPIdouble(), X_GC_child_AisCis_GeneralSpin_MPIdouble(), X_GC_child_AisCis_spin_MPIdouble(), X_GC_child_CisAis_GeneralSpin_MPIdouble(), X_GC_child_CisAis_Hubbard_MPI(), X_GC_child_CisAis_spin_MPIdouble(), X_GC_child_CisAisCjtAjt_Hubbard_MPI(), X_GC_child_CisAisCjuAju_GeneralSpin_MPIdouble(), X_GC_child_CisAisCjuAju_GeneralSpin_MPIsingle(), X_GC_child_CisAisCjuAju_spin_MPIdouble(), X_GC_child_CisAisCjuAju_spin_MPIsingle(), X_GC_child_CisAisCjuAjv_GeneralSpin_MPIdouble(), X_GC_child_CisAisCjuAjv_GeneralSpin_MPIsingle(), X_GC_child_CisAisCjuAjv_spin_MPIdouble(), X_GC_child_CisAisCjuAjv_spin_MPIsingle(), X_GC_child_CisAit_GeneralSpin_MPIdouble(), X_GC_child_CisAit_spin_MPIdouble(), X_GC_child_CisAitCiuAiv_spin_MPIdouble(), X_GC_child_CisAitCiuAiv_spin_MPIsingle(), X_GC_child_CisAitCjuAju_GeneralSpin_MPIdouble(), X_GC_child_CisAitCjuAju_GeneralSpin_MPIsingle(), X_GC_child_CisAitCjuAju_spin_MPIdouble(), X_GC_child_CisAitCjuAju_spin_MPIsingle(), X_GC_child_CisAitCjuAjv_GeneralSpin_MPIdouble(), X_GC_child_CisAitCjuAjv_GeneralSpin_MPIsingle(), X_GC_child_CisAjtCkuAku_Hubbard_MPI(), X_GC_child_CisAjtCkuAlv_Hubbard_MPI(), X_GC_child_general_hopp_MPIdouble(), and X_GC_child_general_hopp_MPIsingle().
int DefineList::WRITE |
It is ALWAYS 0 ???
Definition at line 54 of file struct.h.
Referenced by main(), and ReadDefFileNInt().