User Tools

Site Tools


features

Differences

This shows you the differences between two versions of the page.

Link to this comparison view

Both sides previous revisionPrevious revision
Next revision
Previous revision
features [2022/02/08 14:13] tsauefeatures [2025/03/14 10:30] (current) tsaue
Line 1: Line 1:
 +==== New features in DIRAC25 ====
 +
 + 
 +  * **Effective QED-potentials**
 +     * Contributors: Ayaki Sunaga and Trond Saue
 +     * Reference: Ayaki Sunaga, Maen Salman and Trond Saue, 4-component relativistic Hamiltonian with effective QED potentials for molecular calculations, [[https://doi.org/10.1063/5.0116140|J. Chem. Phys.]] **157** (2022) 164101
 +     * //Note//: The potentials perform well for spectroscopic properties. Further testing for core properties are required.
 +     * Vacuum polarization:
 +        * E. A. Uehling, [[https://doi.org/10.1103/physrev.48.55|Phys. Rev.]] **48** (1935) 55 
 +     * Electron self-energy:
 +        *  V. V. Flambaum and J. S. M. Ginges, [[https://doi.org/10.1103/physreva.72.052115|Phys. Rev. A]] **72** (2005) 052115 
 +        * P. Pyykkö and L.-B. Zhao, [[https://doi.org/10.1088/0953-4075/36/8/302|J. Phys. B: At., Mol. Opt. Phys.]] **36** (2003) 1469
 +     * Manual: manual/effqed.html
 +     * Tutorial: tutorials/qed/effqed.html
 +  * **Atomic shift operator**
 +     * Contributor: Trond Saue
 +     * Reference: Ayaki Sunaga, Maen Salman and Trond Saue, 4-component relativistic Hamiltonian with effective QED potentials for molecular calculations, [[https://doi.org/10.1063/5.0116140|J. Chem. Phys.]] **157** (2022) 164101
 +     * Tutorial: tutorials/atomic_shift/tutorial.html
 +  * **Radial powers <r<sup>n</sup>>**
 +     * The keyword .RADPOW in the visualization module scales densities with integer powers of the radial variable r and allows for instance the calculation of radial expectation values <r<sup>n</sup>> 
 +     * Contributor: Trond Saue
 +  * **Approximations to EOM-CCSD** (Partitioned EOM (P-EOM-CCSD); second-order perturbation theory-based EOM (EOM-MBPT(2) and P-EOM-MBPT(2)) are available in the RELCCSD module for excitation and ionization energies.
 +     * Contributors: L. Halbert, A. Gomes
 +     * Reference: L. Halbert and A. S. P. Gomes, The performance of approximate equation of motion coupled cluster for valence and core states of heavy element systems, [[https://doi.org/10.1080/00268976.2023.2246592|Mol. Phys.]] (2023) e2246592
 +  * automatic generated higher-order CC (Loic, Andre)
 +  * automatic generated higher-order CCSDTQ (Jan) + documentation: tenpi default 
 +  * **New ESR/EPR features:**
 +     * Contributor: H. J. Aa. Jensen
 +     * .ESR CI flexible option for defining CI for ESR/EPR calculations
 +     * .G10PPM for *ESR: request g-shifts to 10 ppm accuracy instead of default of +/-1 ppt = 1000 ppm accuracy
 +     * Added .STATE option for *ESR, defining first CI state belonging to ESR multiplet (for example if a "singlet" state is below the "triplet" multiplet).
 +     * .MAXMK2 for *ESR
 +     * .KR CONJ to generate the second state for doublets by Kramers conjugation
 +  * **Updates KRCI module**:
 +     *Contributor: H. J. Aa. Jensen.
 +     * '.CIROOTS' input has been made easier, description in manual has been updated.
 +     * The KRCI module now again works with both LUCIAREL and GASCIP (a fix from 2021 fixed symmetry specification for LUCIAREL but made it not work for GASCIP).
 +  * **DIRAC calculator for the Atomistic Simulation Environment (ASE)** is available.
 +     * Contributors: Carlos M. R. Rocha, Lucas Visscher
 +     * Reference: [[https://qc2.readthedocs.io|DIRAC calculator]]
 +     * Reference: [[https://wiki.fysik.dtu.dk/ase/|Atomic Simulation Environment(ASE)]] 
 +  * **Basis set library has been extended** with 
 +     * “relativistic prolapse-free Gaussian basis sets” RPF-2Z, RPF-3Z, aug-RPF-2Z, and aug-RPF-3Z.
 +        * Contributor: H. J. Aa. Jensen
 +        * Reference: J. S. Sousa, E. F. Gusmão, A. K. N. R. Dias, and R. L. A. Haiduke, Relativistic Prolapse-Free Gaussian Basis Sets of Double- and Triple-ζ Quality for s- and p-Block Elements: (aug-)RPF-2Z and (aug-)RPF-3Z. J. Chem. Theor. Comput. 20, 9991 (2024).[[https://doi.org/10.1021/acs.jctc.4c01211]]
 +      * (aug-)cc-p*Z-PP basis sets from Kirk Peterson for ECP calculations
 +   * **BNCORR now works for Z=1-138**
 +      * Contributor: Kirk Peterson
 +
 +== Revised features ==
 +  * The CODATA2022 set of physical constants is now used as default (taken from [[http://physics.nist.gov/constants]] on June 4, 2024), see also [[https://arxiv.org/abs/2409.03787|arXiv:2409.03787
 +
 +]]
 +  * The [[https://github.com/PCMSolver/pcmsolver|PCMSolver]] module is by default DISABLED, but can be turned on by setting %%--%%pcmsolver=ON in the setup script
 +  * The [[https://gitlab.com/stieltjes|Stieltjes]] module is by default DISABLED, but can be turned on by setting %%--%%stieltjes=ON in the setup script.
 +
 +== Infrastructure changes and fixes ==
 +  * Changed all references to ifort etc. to ifx etc from [[https://www.intel.com/content/www/us/en/developer/tools/oneapi/overview.html|Intel oneAPI]]; ifort is not supported from oneAPI 2025. DIRAC will still compile with ifort.
 +     * Contributor: H. J. Aa. Jensen
 +  * Made all necessary changes for [[https://developer.nvidia.com/hpc-compilers|Nvidia’s NVHPC compilers]] (previously known as PGI compilers).
 +     * Contributor: H. J. Aa. Jensen
 +  * Quit if LUCIAREL is requested for sequential dirac.x (LUCIAREL only works if compiled with MPI).
 +     * Contributor: H. J. Aa. Jensen
 +  *  Better cmake structure for compiling dirac. Now utility programs are small and not the same size as dirac.x.
 +     * Contributor: H. J. Aa. Jensen
 +
 +== Bugfixes ==
 +
 +  * Fix of symmetry problem for KRMCSCF with LUCIAREL and odd number of electrons.
 +     * Contributor: H. J. Aa. Jensen
 +  * Changes and corrections in the definition of one-electron operators "\beta\gamma^5" and "i \beta \alpha".
 +     * One-electron operator type ZiBETAAL was not defined properly in previous code versions. From now on, it is replaced by ZBETAALP and represents the operator "i \beta \alpha_z".
 +     * In previous code versions, the one-electron operator types XiBETAAL and YiBETAAL represented "i \beta \alpha_x" and "i \beta \alpha_y", respectively. From now on, they are replaced by the operator types XBETAALP and YBETAALP, respectively.
 +     * New one-electron operator type BETAGAMMA5 available, representing the time-symmetric operator "\beta\gamma^5". Please note that the operator type iBETAGAMMA5 was already implemented in DIRAC and it also points to "\beta\gamma^5, but with the assignments of time-reversal antisymmetry.
 +     * For more details, please check the manual: `One-electron operators <https://www.diracprogram.org/doc/release-25/manual/one_electron_operators.html#one-electron-operators>`__.
 +     * Contributor: I. A. Aucar.
 +  * Set the correct sign of CC linear and quadratic response functions in the case of more than one time-antisymmetric perturbation operator
 +     * Contributor: A. Gomes.
 +  * Corrections to Dyall basis sets:
 +     * Fixed incorrect definitions for the number of exponents for Zr/Nb/Ru in dyall.acv4z.
 +     * Fixed missing exponents:
 +        * 1x f for Lu in cv2z/ae2z
 +        * 1x d for K in acv4z
 +        * 3x f, 2x g, 1x h for Rb/Sr in acv4z
 +        * 1x g for Ra in acv4z/aae4z
 +        * 1x f for Rf--Cn in aae4z
 +     * Fixed incorrect exponent values:
 +        * 1x s, 1x p, 1x d for Zr in av3z/acv3z/aae3z
 +        * 2x g, 1x h for Pb--Rn in acv4z/aae4z
 +        * 1x g for Tl--Rn in ae4z
 +        * 1x g for Lr in v4z
 +     * Fixed 150+ instances of small rounding errors.
 +     * Contributor: Lukas F. Pasteka
 + 
 +== Improvements ==
 +  * Significantly better performance with GASCIP configuration interaction code
 +    * Contributor: H. J. Aa. Jensen
 +  * More robust symmetry handling for *KRCI calculations
 +    * Contributor: H. J. Aa. Jensen
 +  * The atomic supersymmetry can be switched to the linear symmetry by *SYMMETRY .LINEAR option. It will be helpful in the calculation of an atom under an external electric field.
 +    * Contributor: Ayaki Sunaga
 + 
 +==== New features in DIRAC24 ====
 +
 +  * New functionality with ExaCorr:
 +    * Calculation of linear response properties with CCSD wavefunctions.
 +      * Contributors: Xiang Yuan,  Loic Halbert, Johann Pototschnig, Anastasios Papadopoulos, Lucas Visscher and Andre Gomes.
 +      * Reference: Xiang Yuan, Loic Halbert, Johann Valentin Pototschnig, Anastasios Papadopoulos, Sonia Coriani, Lucas Visscher, and Andre Severo Pereira Gomes, Formulation and Implementation of Frequency-Dependent Linear Response Properties with Relativistic Coupled Cluster Theory for GPU-Accelerated Computer Architectures, J. Chem. Theory Comput. 20, 677 (2024) https://doi.org/10.1021/acs.jctc.3c00812
 +      * Manual: CCCILR https://diracprogram.org/doc/release-24/manual/wave_function/exacorr.html#cccilr
 +      * Tutorial: not yet available; please have a look at examples in the testset.
 +    * Calculation of quadratic response properties CCSD wavefunctions. 
 +      * Contributors: Xiang Yuan,  Loic Halbert, Lucas Visscher and Andre Gomes.
 +      * Reference: Xiang Yuan, Loic Halbert, Lucas Visscher, and Andre Severo Pereira Gomes, Frequency-Dependent Quadratic Response Properties and Two-Photon Absorption from Relativistic Equation-of-Motion Coupled Cluster Theory, J. Chem. Theory Comput. 19, 9248 (2023) https://doi.org/10.1021/acs.jctc.3c01011
 +      * Manual: CCCIQR https://diracprogram.org/doc/release-24/manual/wave_function/exacorr.html#ccciqr
 +      * Tutorial: not yet available; please have a look at examples in the testset.      
 +    * Calculation of energies with equation of motion coupled cluster for excitation (EOM-EE-CCSD), ionization  (EOM-IP-CCSD), and electron affinity (EOM-EA-CCSD) models.
 +      * Contributors: Xiang Yuan,  Loic Halbert, Lucas Visscher and Andre Gomes.
 +      * Reference: Xiang Yuan, PhD thesis (2024), https://doi.org/10.5463/thesis.505
 +      * Manual: EXEOM https://diracprogram.org/doc/release-24/manual/wave_function/exacorr.html#exeom  see also https://www.diracprogram.org/doc/release-24/manual/wave_function/exacorr.html#id10
 +      * Tutorial: not yet available; please have a look at examples in the testset.
 +    * Two-body reduced density matrix for CCSD ground-state wavefunctions.
 +      * Contributors: Loic Halbert, Andre Gomes
 +      * Manual: GS2RDM https://diracprogram.org/doc/release-24/manual/wave_function/exacorr.html#gs2rdm
 +      * Tutorial: not yet available; please have a look at examples in the testset.
 +      
 +
 +== Revised features in DIRAC24 ==
 +
 +  * Restart from density matrices of CC for first-order properties. 
 +    * Contributors: Trond Saue, Andre Gomes
 +      * Manual: RDCCDM https://diracprogram.org/doc/release-24/manual/properties.html#rdccdm
 +  * Update of DIRAC schema which defines the information stored on CHECKPOINT.h5.
 +    * Essential symmetry information added.
 +    * MO coefficients for C<sub>1</sub> symmetry optionally stored for restarts without use of symmetry.
 +    * Occupation of spinors in SCF added. 
 +    * Non-default property integrals stored on separate file to reduce the size of the checkpoint file.
 +    * Copy of input files stored.
 +    * Contributors: Lucas Visscher, Trond Saue
 +
 +== Improvements ==
 +
 +  * Support for AMD GPUs with ExaCorr (TAL-SH, work in progress to enable distributed calculations with ExaTensor), in addition to the NVIDIA GPU support (TAL-SH and ExaTensor).
 +    * Contributors: Johann Pototschnig, Jan Brandejs and Andre Gomes.
 +    * For further information on ExaTensor and TAL-SH as used in DIRAC, see https://github.com/RelMBdev/ExaTENSOR/tree/dirac
 +      * Note : ROCM versions 5.7+ should be used. Earlier ROCM versions may result in code that compiles but may show runtime errors (e.g. HSA_STATUS_ERROR_MEMORY_APERTURE_VIOLATION, or values different than reference ones in the tests). A potential workaround for earlier versions is to reduce hipcc optimization level to -O1.
 +
 +
 +==== New features in DIRAC23 ====
 +
 +  * Calculation of Parity-Violating Nuclear Spin-Rotation Tensors. Activated with ".PVCSR"
 +    * Contributor: I. Agustín Aucar.
 +    * Reference: Ignacio Agustín Aucar and Anastasia Borschevsky, Relativistic study of parity-violating nuclear spin-rotation tensors. J. Chem. Phys. 155, 134307 (2021) https://doi.org/10.1063/5.0065487
 +    * Manual: PVCSR http://www.diracprogram.org/doc/release-23/manual/properties.html#pvcsr
 +    * Tutorial: http://www.diracprogram.org/doc/release-23/tutorials/pvcsr/tutorial.html
 +
 +  * Calculation of oscillator strengths beyond the electric dipole approximation in the generalized velocity representation
 +    * Contributors: Martin van Horn, Trond Saue, and Nanna Holmgaard List.
 +    * Reference: M. van Horn, T. Saue, N. H. List. Probing Chirality across the Electromagnetic Spectrum with the Full Semi-Classical Light-Matter Interaction. J. Chem. Phys. 156, 054113 (2022) https://doi.org/10.1063/5.0077502
 +    * Manual: VPOL http://www.diracprogram.org/doc/release-23/manual/properties/excitation.html#vpole
 +    * Tutorial: http://www.diracprogram.org/doc/release-23/tutorials/x_ray/BED_Ba/tutorial.html
 +
 +  * (e)amfX2C (improvement of AMFI): (extended) atomic-mean-field two-electron scalar and spin-orbit picture-change corrections for two-component Hamiltonian calculations
 +    * Contributors: Stefan Knecht, Michal Repsiky, Hans Joergen Aa. Jensen and Trond Saue.
 +    * Reference: Stefan Knecht, Michal Repisky, Hans Jørgen Aagaard Jensen, and Trond Saue, Exact two-component Hamiltonians for relativistic quantum chemistry: Two-electron picture-change corrections made simple, J. Chem. Phys. 157, 114106 (2022) https://doi.org/10.1063/5.0095112
 +    * Manual: XAMFI http://www.diracprogram.org/doc/release-23/manual/xamfi.html
 +    * Tutorial: http://www.diracprogram.org/doc/release-23/tutorials/two_component_hamiltonians/xamfX2C.html
 +
 +  * ExaCorr module works now also with contracted basis functions.
 +    * Contributor: Lucas Visscher.
 +
 +  * Basis set library has been extended with basis sets with diffuse functions for s and d blocks, dyall.aXNz basis sets. The Dyall basis sets can now be downloaded from the [[https://zenodo.org/record/7606547#.Y_TZo4DMJkg|zenodo]] repository.
 +    * Contributor: Ken Dyall.
 +
 +== Infrastructure changes ==
 +
 +  * HDF5 checkpoint file is now default for data handling
 +    * Contributor: Lucas Visscher
 +    * User manual: Data storage in DIRAC http://www.diracprogram.org/doc/release-23/manual/data.html
 +    * Developer manual: The CHECKPOINT.h5 file http://www.diracprogram.org/doc/release-23/development/checkpoint.html
 +
 +== Revised features ==
 +
 +  * Added a CI gradient convergence threshold option '.THRGCI' to '\*KRCICALC' (could not be changed by user previously).
 +    * Contributor: H. J. Aa. Jensen.
 +
 +== Performance improvements ==
 +
 +  * Improved code in luciarel CI program. Note that KRMC and KRCI by default uses luciarel.
 +    * Contributor: Andreas Nyvang.
 +    * numerical stability has been improved in the complex parallel diagonalization routine
 +    * convergence algorithm has also been changed, with considerable improvement in convergence rate. In particular, the truncation of the reduced space in the Davidson iterations is now done in a much better way, leading to the improvement in convergence rate. Both for real and complex parallel cases.
 +
 +== Bugfixes ==
 +
 +  * Default for .MVO has been corrected, so it now behaves as expected: modified virtual orbitals based on the Fock potential from the doubly-occupied molecular orbitals after an open-shell SCF calculation (H. J. Aa. Jensen).
 +
 ==== New features in DIRAC22 ==== ==== New features in DIRAC22 ====
 + 
      
-  * ** Change of licence ** : [[https://opensource.org/licenses/LGPL-2.1|GNU Lesser General Public License v2.1 only]] +  * ** New licence **: [[https://opensource.org/licenses/LGPL-2.1|GNU Lesser General Public License v2.1]]only
   * ** Electronic circular dichroism (ECD) beyond lowest-order -- full light-matter interaction**. Contributors: Martin van Horn, Trond Saue and Nanna Holmgaard List   * ** Electronic circular dichroism (ECD) beyond lowest-order -- full light-matter interaction**. Contributors: Martin van Horn, Trond Saue and Nanna Holmgaard List
         * Reference : M. van Horn, T. Saue, N. H. List. // Probing Chirality across the Electromagnetic Spectrum with the Full Semiclassical Light-Matter Interaction. // [[https://doi.org/10.1063/5.0077502|J. Chem. Phys. (in press) (2022)]] [[https://doi.org/10.33774/chemrxiv-2021-j1hcz-v2| ChemRxiv]]         * Reference : M. van Horn, T. Saue, N. H. List. // Probing Chirality across the Electromagnetic Spectrum with the Full Semiclassical Light-Matter Interaction. // [[https://doi.org/10.1063/5.0077502|J. Chem. Phys. (in press) (2022)]] [[https://doi.org/10.33774/chemrxiv-2021-j1hcz-v2| ChemRxiv]]
Line 12: Line 208:
   * **Polarizable Embedding with Complex Polarization Propagator**.    * **Polarizable Embedding with Complex Polarization Propagator**. 
   * Contributors: Joel Creutzberg, Erik D. Hedegård   * Contributors: Joel Creutzberg, Erik D. Hedegård
-        * Reference: // Polarizable embedding complex polarization propagator in four- and two-component frameworks. // [[https://arxiv.org/abs/2112.07721|  arXiv:2112.07721 [physics.chem-ph]]] +        * Reference: // Polarizable embedding complex polarization propagator in four- and two-component frameworks. // [[https://arxiv.org/abs/2112.07721| arXiv:2112.07721]] 
-        * Manual: +        * Manual: [[http://diracprogram.org/doc/master/manual/index.html|*PEQM]] and tutorial [[http://diracprogram.org/doc/master/tutorials/polarizable_embedding/pe_response.html|PE-TDDFT calculations of excitation energies and solvent shifts¶]] 
  
 == Infrastructure changes and fixes == == Infrastructure changes and fixes ==
Line 27: Line 223:
 == Improvements == == Improvements ==
   * DIIS replaced by [[https://pubs.acs.org/doi/10.1021/ct501114q|CROP]] algorithm in ExaCorr module. Contributors:  Chima Chibueze and Lucas Visscher.   * DIIS replaced by [[https://pubs.acs.org/doi/10.1021/ct501114q|CROP]] algorithm in ExaCorr module. Contributors:  Chima Chibueze and Lucas Visscher.
-        * Reference ExaCorr: [[https://doi.org/10.1021/acs.jctc.1c00260|J.V. Pototschnig et al.,J. Chem. Theory Comput. 17 (2021) 5509−5529.]]+        * Reference ExaCorr: J.V. Pototschnig et al., [[https://doi.org/10.1021/acs.jctc.1c00260|J. Chem. Theory Comput. 17 (2021) 5509−5529.]]
         * Manual: [[http://www.diracprogram.org/doc/release-22/manual/wave_function/exacorr.html|EXACC]]         * Manual: [[http://www.diracprogram.org/doc/release-22/manual/wave_function/exacorr.html|EXACC]]
    
features.1644329602.txt.gz · Last modified: 2022/02/08 14:13 by tsaue

Donate Powered by PHP Valid HTML5 Valid CSS Driven by DokuWiki