LCOV - code coverage report
Current view: top level - src - cp_control_types.F (source / functions) Coverage Total Hit
Test: CP2K Regtests (git:936074a) Lines: 97.2 % 217 211
Test Date: 2025-12-04 06:27:48 Functions: 46.6 % 58 27

            Line data    Source code
       1              : !--------------------------------------------------------------------------------------------------!
       2              : !   CP2K: A general program to perform molecular dynamics simulations                              !
       3              : !   Copyright 2000-2025 CP2K developers group <https://cp2k.org>                                   !
       4              : !                                                                                                  !
       5              : !   SPDX-License-Identifier: GPL-2.0-or-later                                                      !
       6              : !--------------------------------------------------------------------------------------------------!
       7              : 
       8              : ! **************************************************************************************************
       9              : !> \brief Defines control structures, which contain the parameters and the
      10              : !>      settings for the DFT-based calculations.
      11              : ! **************************************************************************************************
      12              : MODULE cp_control_types
      13              :    USE cp_fm_types,                     ONLY: cp_fm_release,&
      14              :                                               cp_fm_type
      15              :    USE eeq_input,                       ONLY: eeq_solver_type
      16              :    USE input_constants,                 ONLY: do_full_density,&
      17              :                                               rtp_bse_ham_G0W0,&
      18              :                                               rtp_method_tddft,&
      19              :                                               use_mom_ref_coac
      20              :    USE kinds,                           ONLY: default_path_length,&
      21              :                                               default_string_length,&
      22              :                                               dp
      23              :    USE pair_potential_types,            ONLY: pair_potential_p_release,&
      24              :                                               pair_potential_p_type
      25              :    USE qs_cdft_types,                   ONLY: cdft_control_create,&
      26              :                                               cdft_control_release,&
      27              :                                               cdft_control_type
      28              :    USE smeagol_control_types,           ONLY: smeagol_control_create,&
      29              :                                               smeagol_control_release,&
      30              :                                               smeagol_control_type
      31              :    USE xas_control,                     ONLY: xas_control_release,&
      32              :                                               xas_control_type
      33              :    USE xas_tdp_types,                   ONLY: xas_tdp_control_create,&
      34              :                                               xas_tdp_control_release,&
      35              :                                               xas_tdp_control_type
      36              : #include "./base/base_uses.f90"
      37              : 
      38              :    IMPLICIT NONE
      39              : 
      40              :    PRIVATE
      41              : 
      42              : !***************************************************************************************************
      43              : !\brief Control parameters for hairy-probes DFT
      44              : !***************************************************************************************************
      45              :    TYPE hairy_probes_type
      46              :       REAL(KIND=dp)                        :: alpha = 0.0_dp     ! solution probes parameter
      47              :       REAL(KIND=dp)                        :: mu = 0.0_dp        ! chemical potenatial of electrons in reservoir
      48              :       REAL(KIND=dp)                        :: T = 0.0_dp         ! temperature of electrons in reservoir
      49              :       REAL(KIND=dp)                        :: eps_hp = 0.0_dp    ! tolerance for accuracy checks on occupation numbers
      50              :       INTEGER                              :: natoms = 0, &
      51              :                                               last_ao = 0, &
      52              :                                               first_ao = 0
      53              :       INTEGER, DIMENSION(:), POINTER       :: atom_ids => NULL() ! atom ids to which the probes are attached
      54              :    END TYPE hairy_probes_type
      55              : 
      56              : ! **************************************************************************************************
      57              : ! \brief Control parameters for pw grids
      58              : ! **************************************************************************************************
      59              :    TYPE pw_grid_option
      60              :       LOGICAL                              :: spherical = .FALSE.
      61              :       LOGICAL                              :: fullspace = .FALSE.
      62              :       INTEGER, DIMENSION(2)                :: distribution_layout = 0
      63              :       INTEGER                              :: blocked = 0
      64              :    END TYPE pw_grid_option
      65              : 
      66              : ! **************************************************************************************************
      67              : ! \brief parameters for EMD/RTP calculations involving MO projections
      68              : ! **************************************************************************************************
      69              :    TYPE proj_mo_type
      70              :       INTEGER, DIMENSION(:), ALLOCATABLE         :: ref_mo_index
      71              :       INTEGER                                    :: ref_mo_spin = 1
      72              :       INTEGER                                    :: ref_nlumo = 0
      73              :       LOGICAL                                    :: sum_on_all_ref = .FALSE.
      74              :       INTEGER, DIMENSION(:), ALLOCATABLE         :: td_mo_index
      75              :       REAL(dp), DIMENSION(:), ALLOCATABLE        :: td_mo_occ
      76              :       INTEGER                                    :: td_mo_spin = 1
      77              :       LOGICAL                                    :: sum_on_all_td = .FALSE.
      78              :       CHARACTER(LEN=default_path_length)         :: ref_mo_file_name = ""
      79              :       LOGICAL                                    :: propagate_ref = .FALSE.
      80              :       TYPE(cp_fm_type), DIMENSION(:), &
      81              :          ALLOCATABLE                       :: mo_ref
      82              :    END TYPE proj_mo_type
      83              : 
      84              :    TYPE proj_mo_p_type
      85              :       TYPE(proj_mo_type), POINTER                :: proj_mo => NULL()
      86              :    END TYPE proj_mo_p_type
      87              : 
      88              : ! **************************************************************************************************
      89              : ! \brief Control parameters for REAL_TIME_PROPAGATION calculations
      90              : ! **************************************************************************************************
      91              :    TYPE rtp_control_type
      92              :       LOGICAL                              :: converged = .FALSE.
      93              :       REAL(KIND=dp)                        :: eps_ener = 0.0_dp
      94              :       INTEGER                              :: max_iter = 0
      95              :       INTEGER                              :: mat_exp = 0
      96              :       INTEGER                              :: propagator = 0
      97              :       LOGICAL                              :: fixed_ions = .FALSE.
      98              :       INTEGER                              :: rtp_method = rtp_method_tddft
      99              :       INTEGER                              :: rtbse_ham = rtp_bse_ham_G0W0
     100              :       INTEGER                              :: initial_wfn = 0
     101              :       REAL(dp)                             :: eps_exp = 0.0_dp
     102              :       LOGICAL                              :: initial_step = .FALSE.
     103              :       LOGICAL                              :: hfx_redistribute = .FALSE.
     104              :       INTEGER                              :: aspc_order = 0
     105              :       INTEGER                              :: sc_check_start = 0
     106              :       LOGICAL                              :: apply_wfn_mix_init_restart = .FALSE.
     107              :       LOGICAL                              :: apply_delta_pulse = .FALSE.
     108              :       LOGICAL                              :: apply_delta_pulse_mag = .FALSE.
     109              :       LOGICAL                              :: periodic = .FALSE.
     110              :       LOGICAL                              :: linear_scaling = .FALSE.
     111              :       LOGICAL                              :: write_restart = .FALSE.
     112              :       INTEGER                              :: mcweeny_max_iter = 0
     113              :       INTEGER                              :: acc_ref = 0
     114              :       REAL(dp)                             :: mcweeny_eps = 0.0_dp
     115              :       INTEGER, DIMENSION(3)                :: delta_pulse_direction = 0
     116              :       REAL(KIND=dp)                        :: delta_pulse_scale = 0.0_dp
     117              :       LOGICAL                              :: velocity_gauge = .FALSE.
     118              :       REAL(KIND=dp), DIMENSION(3)          :: field = 0.0_dp
     119              :       REAL(KIND=dp), DIMENSION(3)          :: vec_pot = 0.0_dp
     120              :       LOGICAL                              :: nl_gauge_transform = .FALSE.
     121              :       LOGICAL                              :: is_proj_mo = .FALSE.
     122              :       TYPE(proj_mo_p_type), DIMENSION(:), &
     123              :          POINTER                :: proj_mo_list => NULL()
     124              :       ! Switch to turn on moments trace saving
     125              :       LOGICAL                              :: save_local_moments = .FALSE.
     126              :       INTEGER                              :: moment_trace_ref_type = use_mom_ref_coac
     127              :       REAL(dp), DIMENSION(:), POINTER      :: moment_trace_user_ref_point => NULL()
     128              :       REAL(dp)                             :: ft_damping = -1.0_dp
     129              :       REAL(dp)                             :: ft_t0 = 0.0_dp
     130              :       ! Index 1 : number of the element, Index 2 : coordinates
     131              :       ! e.g. if xx and xz elements are to be printed
     132              :       ! print_pol_elements(1,1) = 1
     133              :       ! print_pol_elements(1,2) = 1
     134              :       ! print_pol_elements(2,1) = 1
     135              :       ! print_pol_elements(2,2) = 3
     136              :       INTEGER, DIMENSION(:, :), POINTER    :: print_pol_elements => NULL()
     137              :       LOGICAL                              :: pade_requested = .FALSE.
     138              :       REAL(dp)                             :: pade_e_min = 0.0_dp
     139              :       REAL(dp)                             :: pade_e_step = 0.02_dp
     140              :       REAL(dp)                             :: pade_e_max = 100.0_dp
     141              :       REAL(dp)                             :: pade_fit_e_min = 0.0_dp
     142              :       REAL(dp)                             :: pade_fit_e_max = 300.0_dp
     143              :    END TYPE rtp_control_type
     144              : 
     145              : ! **************************************************************************************************
     146              : ! \brief Control parameters for DFTB calculations
     147              : ! **************************************************************************************************
     148              :    TYPE dftb_control_type
     149              :       LOGICAL                              :: self_consistent = .FALSE.
     150              :       LOGICAL                              :: orthogonal_basis = .FALSE.
     151              :       LOGICAL                              :: dispersion = .FALSE.
     152              :       INTEGER                              :: dispersion_type = 0
     153              :       LOGICAL                              :: dftb3_diagonal = .FALSE.
     154              :       LOGICAL                              :: hb_sr_damp = .FALSE.
     155              :       REAL(KIND=dp)                        :: hb_sr_para = 0.0_dp
     156              :       REAL(KIND=dp)                        :: eps_disp = 0.0_dp
     157              :       REAL(KIND=dp)                        :: epscn = 0.0_dp
     158              :       REAL(KIND=dp)                        :: exp_pre = 0.0_dp
     159              :       REAL(KIND=dp)                        :: scaling = 0.0_dp
     160              :       REAL(KIND=dp)                        :: rcdisp = 0.0_dp
     161              :       REAL(KIND=dp), DIMENSION(3)          :: sd3 = 0.0_dp
     162              :       REAL(KIND=dp), DIMENSION(4)          :: sd3bj = 0.0_dp
     163              :       LOGICAL                              :: do_ewald = .FALSE.
     164              :       CHARACTER(LEN=default_path_length)   :: sk_file_path = ""
     165              :       CHARACTER(LEN=default_path_length)   :: sk_file_list = ""
     166              :       CHARACTER(LEN=default_string_length), &
     167              :          DIMENSION(:, :), POINTER          :: sk_pair_list => NULL()
     168              :       CHARACTER(LEN=default_path_length)   :: uff_force_field = ""
     169              :       CHARACTER(LEN=default_path_length)   :: dispersion_parameter_file = ""
     170              :    END TYPE dftb_control_type
     171              : 
     172              : ! **************************************************************************************************
     173              : ! \brief Control parameters for xTB calculations
     174              : ! **************************************************************************************************
     175              :    TYPE xtb_control_type
     176              :       !
     177              :       INTEGER                              :: gfn_type = 1
     178              :       !
     179              :       LOGICAL                              :: do_ewald = .FALSE.
     180              :       LOGICAL                              :: do_tblite = .FALSE.
     181              :       !
     182              :       INTEGER                              :: sto_ng = 0
     183              :       INTEGER                              :: h_sto_ng = 0
     184              :       INTEGER                              :: tblite_method = 0
     185              :       !
     186              :       INTEGER                              :: vdw_type = -1
     187              :       CHARACTER(LEN=default_path_length)   :: parameter_file_path = ""
     188              :       CHARACTER(LEN=default_path_length)   :: parameter_file_name = ""
     189              :       !
     190              :       CHARACTER(LEN=default_path_length)   :: dispersion_parameter_file = ""
     191              :       REAL(KIND=dp)                        :: epscn = 0.0_dp
     192              :       REAL(KIND=dp)                        :: rcdisp = 0.0_dp
     193              :       REAL(KIND=dp)                        :: s6 = 0.0_dp, s8 = 0.0_dp
     194              :       REAL(KIND=dp)                        :: a1 = 0.0_dp, a2 = 0.0_dp
     195              :       !
     196              :       REAL(KIND=dp)                        :: ks = 0.0_dp, kp = 0.0_dp, kd = 0.0_dp, ksp = 0.0_dp, k2sh = 0.0_dp
     197              :       REAL(KIND=dp)                        :: kg = 0.0_dp, kf = 0.0_dp
     198              :       REAL(KIND=dp)                        :: kcns = 0.0_dp, kcnp = 0.0_dp, kcnd = 0.0_dp
     199              :       REAL(KIND=dp)                        :: ken = 0.0_dp
     200              :       REAL(KIND=dp)                        :: ksen = 0.0_dp, kpen = 0.0_dp, kden = 0.0_dp
     201              :       REAL(KIND=dp)                        :: ben = 0.0_dp
     202              :       REAL(KIND=dp)                        :: kxr = 0.0_dp, kx2 = 0.0_dp
     203              :       REAL(KIND=dp)                        :: enscale = 0.0_dp
     204              :       !
     205              :       LOGICAL                              :: xb_interaction = .FALSE.
     206              :       LOGICAL                              :: do_nonbonded = .FALSE.
     207              :       LOGICAL                              :: coulomb_interaction = .FALSE.
     208              :       LOGICAL                              :: coulomb_lr = .FALSE.
     209              :       LOGICAL                              :: tb3_interaction = .FALSE.
     210              :       LOGICAL                              :: check_atomic_charges = .FALSE.
     211              :       LOGICAL                              :: var_dipole = .FALSE.
     212              :       !
     213              :       REAL(KIND=dp)                        :: xb_radius = 0.0_dp
     214              :       REAL(KIND=dp)                        :: coulomb_sr_cut = 0.0_dp
     215              :       REAL(KIND=dp)                        :: coulomb_sr_eps = 0.0_dp
     216              :       !
     217              :       CHARACTER(LEN=default_string_length), &
     218              :          DIMENSION(:, :), POINTER          :: kab_param => NULL()
     219              :       INTEGER, DIMENSION(:, :), POINTER    :: kab_types => NULL()
     220              :       INTEGER                              :: kab_nval = 0
     221              :       REAL, DIMENSION(:), POINTER          :: kab_vals => NULL()
     222              :       !
     223              :       TYPE(pair_potential_p_type), POINTER :: nonbonded => NULL()
     224              :       REAL(KIND=dp)                        :: eps_pair = 0.0_dp
     225              :       REAL(KIND=dp), DIMENSION(:, :), &
     226              :          POINTER                           :: rcpair => NULL()
     227              :       !
     228              :       ! SRB terms
     229              :       REAL(KIND=dp)                        :: ksrb = 0.0_dp, esrb = 0.0_dp, gscal = 0.0_dp
     230              :       REAL(KIND=dp)                        :: c1srb = 0.0_dp, c2srb = 0.0_dp, shift = 0.0_dp
     231              :       !
     232              :       ! EN shift in EEQ (molecular=1 or crystaline=2)
     233              :       INTEGER                              :: enshift_type = 1
     234              :       TYPE(eeq_solver_type)                :: eeq_sparam ! parameters for EEQ solver
     235              :    END TYPE xtb_control_type
     236              : 
     237              : ! **************************************************************************************************
     238              : ! \brief Control parameters for semi empirical calculations
     239              : ! **************************************************************************************************
     240              :    TYPE semi_empirical_control_type
     241              :       LOGICAL                              :: orthogonal_basis = .FALSE.
     242              :       LOGICAL                              :: analytical_gradients = .FALSE.
     243              :       LOGICAL                              :: force_kdsod_EX = .FALSE.
     244              :       LOGICAL                              :: do_ewald = .FALSE., do_ewald_r3 = .FALSE., do_ewald_gks = .FALSE.
     245              :       INTEGER                              :: integral_screening = 0, periodic_type = 0
     246              :       INTEGER                              :: max_multipole = 0
     247              :       INTEGER                              :: ga_ncells = 0
     248              :       REAL(KIND=dp)                        :: delta = 0.0_dp
     249              :       ! Dispersion pair potential
     250              :       LOGICAL                              :: dispersion = .FALSE.
     251              :       REAL(KIND=dp)                        :: rcdisp = 0.0_dp
     252              :       REAL(KIND=dp)                        :: epscn = 0.0_dp
     253              :       REAL(KIND=dp), DIMENSION(3)          :: sd3 = 0.0_dp
     254              :       CHARACTER(LEN=default_path_length)   :: dispersion_parameter_file = ""
     255              :       ! Parameters controlling the evaluation of the integrals
     256              :       REAL(KIND=dp)                        :: cutoff_lrc = 0.0_dp, taper_lrc = 0.0_dp, range_lrc = 0.0_dp
     257              :       REAL(KIND=dp)                        :: cutoff_cou = 0.0_dp, taper_cou = 0.0_dp, range_cou = 0.0_dp
     258              :       REAL(KIND=dp)                        :: cutoff_exc = 0.0_dp, taper_exc = 0.0_dp, range_exc = 0.0_dp
     259              :       REAL(KIND=dp)                        :: taper_scr = 0.0_dp, range_scr = 0.0_dp
     260              :    END TYPE semi_empirical_control_type
     261              : 
     262              : ! **************************************************************************************************
     263              : ! \brief Control parameters for GAPW method within QUICKSTEP ***
     264              : ! **************************************************************************************************
     265              :    TYPE gapw_control_type
     266              :       INTEGER                              :: basis_1c = 0
     267              :       REAL(KIND=dp)                        :: eps_fit = 0.0_dp, &
     268              :                                               eps_iso = 0.0_dp, &
     269              :                                               eps_Vrho0 = 0.0_dp, &
     270              :                                               eps_svd = 0.0_dp, &
     271              :                                               eps_cpc = 0.0_dp
     272              :       INTEGER                              :: ladd_rho0 = 0, &
     273              :                                               lmax_rho0 = 0, &
     274              :                                               lmax_sphere = 0, &
     275              :                                               quadrature = 0
     276              :       LOGICAL                              :: alpha0_hard_from_input = .FALSE., &
     277              :                                               force_paw = .FALSE., &
     278              :                                               non_paw_atoms = .FALSE., &
     279              :                                               nopaw_as_gpw = .FALSE.
     280              :       REAL(KIND=dp)                        :: alpha0_hard = 0.0_dp
     281              :       REAL(KIND=dp)                        :: max_rad_local = 0.0_dp
     282              :    END TYPE gapw_control_type
     283              : 
     284              : ! **************************************************************************************************
     285              : ! \brief parameters for calculations involving a time dependent electric field
     286              : ! **************************************************************************************************
     287              :    TYPE efield_type
     288              :       REAL(KIND=dp)                        :: actual_time = 0.0_dp
     289              :       REAL(KIND=dp), DIMENSION(:), POINTER :: polarisation => NULL()
     290              :       INTEGER                              :: envelop_id = 0
     291              :       REAL(KIND=dp), DIMENSION(:), POINTER :: envelop_r_vars => NULL()
     292              :       INTEGER, DIMENSION(:), POINTER       :: envelop_i_vars => NULL()
     293              :       REAL(KIND=dp)                        :: strength = 0.0_dp
     294              :       REAL(KIND=dp)                        :: phase_offset = 0.0_dp
     295              :       REAL(KIND=dp)                        :: wavelength = 0.0_dp
     296              :       REAL(KIND=dp), DIMENSION(3)          :: vec_pot_initial = 0.0_dp
     297              :    END TYPE efield_type
     298              : 
     299              :    TYPE efield_p_type
     300              :       TYPE(efield_type), POINTER           :: efield => NULL()
     301              :    END TYPE efield_p_type
     302              : 
     303              : ! **************************************************************************************************
     304              : ! \brief parameters for calculations involving a time dependent electric field
     305              : ! **************************************************************************************************
     306              :    TYPE period_efield_type
     307              :       LOGICAL                              :: displacement_field = .FALSE.
     308              :       REAL(KIND=dp), DIMENSION(3)          :: polarisation = 0.0_dp
     309              :       REAL(KIND=dp), DIMENSION(3)          :: d_filter = 0.0_dp
     310              :       REAL(KIND=dp)                        :: strength = 0.0_dp
     311              :       REAL(KIND=dp), ALLOCATABLE, DIMENSION(:) :: strength_list
     312              :       INTEGER                              :: start_frame = 0
     313              :       INTEGER                              :: end_frame = -1
     314              :    END TYPE period_efield_type
     315              : 
     316              : ! **************************************************************************************************
     317              : ! \brief some parameters useful for mulliken_restraints
     318              : ! **************************************************************************************************
     319              :    TYPE mulliken_restraint_type
     320              :       REAL(KIND=dp)                        :: strength = 0.0_dp
     321              :       REAL(KIND=dp)                        :: TARGET = 0.0_dp
     322              :       INTEGER                              :: natoms = 0
     323              :       INTEGER, POINTER, DIMENSION(:)       :: atoms => NULL()
     324              :    END TYPE mulliken_restraint_type
     325              : 
     326              : ! **************************************************************************************************
     327              : ! \brief some parameters useful for ddapc_restraints
     328              : ! **************************************************************************************************
     329              :    TYPE ddapc_restraint_type
     330              :       INTEGER                              :: ref_count = 0
     331              :       REAL(KIND=dp)                        :: strength = 0.0_dp
     332              :       REAL(KIND=dp)                        :: TARGET = 0.0_dp
     333              :       REAL(KIND=dp)                        :: ddapc_order_p = 0.0_dp
     334              :       INTEGER                              :: functional_form = 0
     335              :       INTEGER                              :: natoms = 0
     336              :       INTEGER, POINTER, DIMENSION(:)       :: atoms => NULL()
     337              :       REAL(KIND=dp), POINTER, DIMENSION(:) :: coeff => NULL()
     338              :       INTEGER                              :: density_type = 0
     339              :    END TYPE ddapc_restraint_type
     340              : 
     341              : ! **************************************************************************************************
     342              : ! \brief some parameters useful for s2_restraints
     343              : ! **************************************************************************************************
     344              :    TYPE s2_restraint_type
     345              :       REAL(KIND=dp)                        :: strength = 0.0_dp
     346              :       REAL(KIND=dp)                        :: TARGET = 0.0_dp
     347              :       REAL(KIND=dp)                        :: s2_order_p = 0.0_dp
     348              :       INTEGER                              :: functional_form = 0
     349              :    END TYPE s2_restraint_type
     350              : 
     351              : ! **************************************************************************************************
     352              : ! \brief some parameters useful for auxiliary density matrix method
     353              : ! **************************************************************************************************
     354              :    TYPE admm_block_type
     355              :       INTEGER, DIMENSION(:), ALLOCATABLE   :: list
     356              :    END TYPE admm_block_type
     357              : 
     358              :    TYPE admm_control_type
     359              :       REAL(KIND=dp)                        :: eps_filter = 0.0_dp
     360              :       INTEGER                              :: admm_type = 0
     361              :       INTEGER                              :: purification_method = 0
     362              :       INTEGER                              :: method = 0
     363              :       LOGICAL                              :: charge_constrain = .FALSE.
     364              :       INTEGER                              :: scaling_model = 0
     365              :       INTEGER                              :: aux_exch_func = 0
     366              :       LOGICAL                              :: aux_exch_func_param = .FALSE.
     367              :       REAL(KIND=dp), DIMENSION(3)          :: aux_x_param = 0.0_dp
     368              :       TYPE(admm_block_type), DIMENSION(:), &
     369              :          ALLOCATABLE                       :: blocks
     370              :    END TYPE admm_control_type
     371              : 
     372              : ! **************************************************************************************************
     373              : ! \brief Parameters for external potential
     374              : ! **************************************************************************************************
     375              :    TYPE expot_control_type
     376              :       LOGICAL                              :: read_from_cube = .FALSE.
     377              :       LOGICAL                              :: maxwell_solver = .FALSE.
     378              :       LOGICAL                              :: static = .FALSE.
     379              :       REAL(KIND=dp)                        :: scaling_factor = 0.0_dp
     380              :    END TYPE expot_control_type
     381              : 
     382              : ! **************************************************************************************************
     383              : ! \brief Parameters useful for Maxwell equation evaluation of external potential
     384              : ! **************************************************************************************************
     385              :    TYPE maxwell_control_type
     386              :       LOGICAL                              :: log_test = .FALSE.
     387              :       INTEGER                              :: int_test = 0
     388              :       REAL(KIND=dp)                        :: real_test = 0.0_dp
     389              :    END TYPE maxwell_control_type
     390              : 
     391              : ! **************************************************************************************************
     392              : ! \brief Control parameters for a QUICKSTEP and KIM-GORDON calculation ***
     393              : !        eps_pgf_orb: Cutoff value for the interaction of the primitive
     394              : !                     Gaussian-type functions (primitive basis functions).
     395              : ! **************************************************************************************************
     396              :    TYPE qs_control_type
     397              :       INTEGER                              :: method_id = 0
     398              :       REAL(KIND=dp)                        :: eps_core_charge = 0.0_dp, &
     399              :                                               eps_kg_orb = 0.0_dp, &
     400              :                                               eps_pgf_orb = 0.0_dp, &
     401              :                                               eps_ppl = 0.0_dp, &
     402              :                                               eps_ppnl = 0.0_dp, &
     403              :                                               eps_rho_gspace = 0.0_dp, &
     404              :                                               eps_rho_rspace = 0.0_dp, &
     405              :                                               eps_filter_matrix = 0.0_dp, &
     406              :                                               eps_gvg_rspace = 0.0_dp, &
     407              :                                               progression_factor = 0.0_dp, &
     408              :                                               relative_cutoff = 0.0_dp
     409              :       LOGICAL                              :: do_almo_scf = .FALSE.
     410              :       LOGICAL                              :: do_ls_scf = .FALSE.
     411              :       LOGICAL                              :: do_kg = .FALSE.
     412              :       LOGICAL                              :: commensurate_mgrids = .FALSE.
     413              :       LOGICAL                              :: realspace_mgrids = .FALSE.
     414              :       LOGICAL                              :: gapw = .FALSE., gapw_xc = .FALSE., gpw = .FALSE., pao = .FALSE.
     415              :       LOGICAL                              :: lrigpw = .FALSE., rigpw = .FALSE.
     416              :       LOGICAL                              :: lri_optbas = .FALSE.
     417              :       LOGICAL                              :: ofgpw = .FALSE.
     418              :       LOGICAL                              :: dftb = .FALSE.
     419              :       LOGICAL                              :: xtb = .FALSE.
     420              :       LOGICAL                              :: semi_empirical = .FALSE.
     421              :       LOGICAL                              :: mulliken_restraint = .FALSE.
     422              :       LOGICAL                              :: ddapc_restraint = .FALSE.
     423              :       LOGICAL                              :: ddapc_restraint_is_spin = .FALSE.
     424              :       LOGICAL                              :: ddapc_explicit_potential = .FALSE.
     425              :       LOGICAL                              :: cdft = .FALSE.
     426              :       LOGICAL                              :: et_coupling_calc = .FALSE.
     427              :       LOGICAL                              :: s2_restraint = .FALSE.
     428              :       INTEGER                              :: do_ppl_method = 0
     429              :       INTEGER                              :: wf_interpolation_method_nr = 0
     430              :       INTEGER                              :: wf_extrapolation_order = 0
     431              :       INTEGER                              :: periodicity = 0
     432              :       REAL(KIND=dp)                        :: pairlist_radius = 0.0_dp
     433              :       REAL(KIND=dp)                        :: cutoff = 0.0_dp
     434              :       REAL(KIND=dp), DIMENSION(:), POINTER :: e_cutoff => NULL()
     435              :       TYPE(mulliken_restraint_type), &
     436              :          POINTER                           :: mulliken_restraint_control => NULL()
     437              :       TYPE(ddapc_restraint_type), &
     438              :          DIMENSION(:), POINTER             :: ddapc_restraint_control => NULL()
     439              :       TYPE(cdft_control_type), POINTER     :: cdft_control => NULL()
     440              :       TYPE(s2_restraint_type), POINTER     :: s2_restraint_control => NULL()
     441              :       TYPE(dftb_control_type), POINTER     :: dftb_control => NULL()
     442              :       TYPE(xtb_control_type), POINTER      :: xtb_control => NULL()
     443              :       TYPE(semi_empirical_control_type), &
     444              :          POINTER                           :: se_control => NULL()
     445              :       TYPE(gapw_control_type), POINTER     :: gapw_control => NULL()
     446              :       TYPE(pw_grid_option)                 :: pw_grid_opt = pw_grid_option()
     447              :       LOGICAL                              :: skip_load_balance_distributed = .FALSE.
     448              :       ! Types of subsystems for embedding
     449              :       LOGICAL                              :: ref_embed_subsys = .FALSE.
     450              :       LOGICAL                              :: cluster_embed_subsys = .FALSE.
     451              :       LOGICAL                              :: high_level_embed_subsys = .FALSE.
     452              :       LOGICAL                              :: dfet_embedded = .FALSE.
     453              :       LOGICAL                              :: dmfet_embedded = .FALSE.
     454              :    END TYPE qs_control_type
     455              : 
     456              : ! **************************************************************************************************
     457              : ! \brief Control parameters for the SCCS models
     458              : ! **************************************************************************************************
     459              :    TYPE sccs_control_type
     460              :       LOGICAL                              :: sccs_activated = .FALSE.
     461              :       INTEGER                              :: derivative_method = 0, &
     462              :                                               max_iter = 0, &
     463              :                                               method_id = 0
     464              :       REAL(KIND=dp)                        :: alpha_solvent = 0.0_dp, &
     465              :                                               beta = 0.0_dp, &
     466              :                                               beta_solvent = 0.0_dp, &
     467              :                                               delta_rho = 0.0_dp, &
     468              :                                               eps_sccs = 0.0_dp, &
     469              :                                               eps_scf = 0.0_dp, &
     470              :                                               epsilon_solvent = 0.0_dp, &
     471              :                                               gamma_solvent = 0.0_dp, &
     472              :                                               mixing = 0.0_dp, &
     473              :                                               rho_zero = 0.0_dp, &
     474              :                                               rho_max = 0.0_dp, &
     475              :                                               rho_min = 0.0_dp
     476              :    END TYPE sccs_control_type
     477              : 
     478              : ! **************************************************************************************************
     479              : ! \brief Control parameters for simplified Tamm Dancoff approximation (sTDA)
     480              : ! \par  ATTRIBUTES
     481              : ! \par  NOTES
     482              : ! **************************************************************************************************
     483              :    TYPE stda_control_type
     484              :       LOGICAL                                :: do_ewald = .FALSE.
     485              :       LOGICAL                                :: do_exchange = .FALSE.
     486              :       REAL(KIND=dp)                          :: hfx_fraction = 0.0_dp
     487              :       REAL(KIND=dp)                          :: eps_td_filter = 0.0_dp
     488              :       REAL(KIND=dp)                          :: mn_alpha = 0.0_dp
     489              :       REAL(KIND=dp)                          :: mn_beta = 0.0_dp
     490              :       REAL(KIND=dp)                          :: coulomb_sr_cut = 0.0_dp
     491              :       REAL(KIND=dp)                          :: coulomb_sr_eps = 0.0_dp
     492              :    END TYPE stda_control_type
     493              : 
     494              : ! **************************************************************************************************
     495              : ! \brief Control parameters for smeared occupation
     496              : ! \par  ATTRIBUTES
     497              : ! \par  NOTES
     498              : ! **************************************************************************************************
     499              :    TYPE smeared_type
     500              :       REAL(KIND=dp), DIMENSION(:), POINTER :: fermia => NULL()
     501              :       REAL(KIND=dp), DIMENSION(:, :), POINTER :: fermib => NULL()
     502              :    END TYPE smeared_type
     503              : 
     504              : ! **************************************************************************************************
     505              : ! \brief Control parameters for a Time-Dependent DFT calculation.
     506              : ! **************************************************************************************************
     507              :    TYPE tddfpt2_control_type
     508              :       !> compute TDDFPT excitation energies and oscillator strengths
     509              :       LOGICAL                              :: enabled = .FALSE.
     510              :       !> number of excited states to converge
     511              :       INTEGER                              :: nstates = 0
     512              :       !> maximal number of iterations to be performed
     513              :       INTEGER                              :: niters = 0
     514              :       !> maximal number of Krylov space vectors
     515              :       INTEGER                              :: nkvs = 0
     516              :       !> number of unoccupied (virtual) molecular orbitals to consider
     517              :       INTEGER                              :: nlumo = 0
     518              :       !> minimal number of MPI processes to be used per excited state
     519              :       INTEGER                              :: nprocs = 0
     520              :       !> type of kernel function/approximation to use
     521              :       INTEGER                              :: kernel = 0
     522              :       !> type of spin excitations to compute
     523              :       INTEGER                              :: spinflip = 0
     524              :       !> for full kernel, do we have HFX/ADMM
     525              :       LOGICAL                              :: do_hfx = .FALSE.
     526              :       LOGICAL                              :: do_admm = .FALSE.
     527              :       !> for full kernel, do we have short-range/long-range HFX and/or Kxc potential
     528              :       LOGICAL                              :: do_hfxsr = .FALSE.
     529              :       LOGICAL                              :: hfxsr_re_int = .TRUE.
     530              :       INTEGER                              :: hfxsr_primbas = 0
     531              :       LOGICAL                              :: do_hfxlr = .FALSE.
     532              :       REAL(KIND=dp)                        :: hfxlr_rcut = 0.0_dp, hfxlr_scale = 0.0_dp
     533              :       LOGICAL                              :: do_exck = .FALSE.
     534              :       !> options used in sTDA calculation (Kernel)
     535              :       TYPE(stda_control_type)              :: stda_control = stda_control_type()
     536              :       !> algorithm to correct orbital energies
     537              :       INTEGER                              :: oe_corr = 0
     538              :       !> eigenvalue shifts
     539              :       REAL(KIND=dp)                        :: ev_shift = 0.0_dp, eos_shift = 0.0_dp
     540              :       !> active orbitals
     541              :       INTEGER, DIMENSION(2)                :: nactive = -1
     542              :       !> target accuracy
     543              :       REAL(kind=dp)                        :: conv = 0.0_dp
     544              :       !> the smallest excitation amplitude to print
     545              :       REAL(kind=dp)                        :: min_excitation_amplitude = 0.0_dp
     546              :       !> threshold which controls when two wave functions considered to be orthogonal:
     547              :       !> maxabs(Ci^T * S * Cj) <= orthogonal_eps
     548              :       REAL(kind=dp)                        :: orthogonal_eps = 0.0_dp
     549              :       !> read guess wave functions from restart file if exists
     550              :       LOGICAL                              :: is_restart = .FALSE.
     551              :       !> compute triplet excited states using spin-unpolarised molecular orbitals
     552              :       LOGICAL                              :: rks_triplets = .FALSE.
     553              :       !> local resolution of identity for Coulomb contribution
     554              :       LOGICAL                              :: do_lrigpw = .FALSE.
     555              :       !> smeared occupation
     556              :       LOGICAL                              :: do_smearing = .FALSE.
     557              :       !> dynamical correlation
     558              :       LOGICAL                              :: do_bse = .FALSE.
     559              :       ! automatic generation of auxiliary basis for LRI-TDDFT
     560              :       INTEGER                              :: auto_basis_p_lri_aux = 1
     561              :       !> use symmetric definition of ADMM Kernel correction
     562              :       LOGICAL                              :: admm_symm = .FALSE.
     563              :       !> Use/Ignore possible ADMM Kernel XC correction
     564              :       LOGICAL                              :: admm_xc_correction = .FALSE.
     565              :       ! Compute exciton descriptors
     566              :       LOGICAL                              :: do_exciton_descriptors = .FALSE.
     567              :       LOGICAL                              :: do_directional_exciton_descriptors = .FALSE.
     568              :       !
     569              :       ! DIPOLE_MOMENTS subsection
     570              :       !
     571              :       ! form of the dipole operator used to compute oscillator strengths
     572              :       INTEGER                              :: dipole_form = 0
     573              :       !> type of the reference point used for calculation of electrostatic dipole moments
     574              :       INTEGER                              :: dipole_reference = 0
     575              :       !> user-defined reference point
     576              :       REAL(kind=dp), DIMENSION(:), POINTER :: dipole_ref_point => NULL()
     577              :       !
     578              :       ! SOC subsection
     579              :       LOGICAL                              :: do_soc = .FALSE.
     580              :       !
     581              :       ! MGRID subsection
     582              :       !
     583              :       !> number of plain-wave grids
     584              :       INTEGER                              :: mgrid_ngrids = 0
     585              :       !> create commensurate grids (progression factor and cutoff values of sub-grids will be ignored)
     586              :       LOGICAL                              :: mgrid_commensurate_mgrids = .FALSE.
     587              :       !> signals that MGRID section has been explicitly given. Other mgrid_* variables
     588              :       !> are not initialised when it is equal to .FALSE. as in this case the default
     589              :       !> set of plain-wave grids will be used
     590              :       LOGICAL                              :: mgrid_is_explicit = .FALSE.
     591              :       !> same as qs_control%realspace_mgrids
     592              :       LOGICAL                              :: mgrid_realspace_mgrids = .FALSE.
     593              :       !> do not perform load balancing
     594              :       LOGICAL                              :: mgrid_skip_load_balance = .FALSE.
     595              :       !> cutoff value at the finest grid level
     596              :       REAL(kind=dp)                        :: mgrid_cutoff = 0.0_dp
     597              :       !> cutoff at the next grid level will be smaller then the cutoff
     598              :       !> at the current grid by this number of times
     599              :       REAL(kind=dp)                        :: mgrid_progression_factor = 0.0_dp
     600              :       !> cutoff that determines to which grid a particular Gaussian function will be mapped
     601              :       REAL(kind=dp)                        :: mgrid_relative_cutoff = 0.0_dp
     602              :       !> manually provided the list of cutoff values for each grid level
     603              :       !> (when it is null(), the cutoff values will be assigned automatically)
     604              :       REAL(kind=dp), DIMENSION(:), POINTER :: mgrid_e_cutoff => NULL()
     605              :       !> Parameter for smeared occupation TDA
     606              :       TYPE(smeared_type), DIMENSION(:), POINTER :: smeared_occup => NULL()
     607              :    END TYPE tddfpt2_control_type
     608              : 
     609              : ! **************************************************************************************************
     610              : !> \brief
     611              : ! **************************************************************************************************
     612              :    TYPE rixs_control_type
     613              : 
     614              :       TYPE(tddfpt2_control_type), POINTER     :: tddfpt2_control => NULL()
     615              :       TYPE(xas_tdp_control_type), POINTER     :: xas_tdp_control => NULL()
     616              : 
     617              :    END TYPE rixs_control_type
     618              : 
     619              : ! **************************************************************************************************
     620              : ! \brief Control parameters for a DFT calculation
     621              : ! \par History
     622              : !      10.2019 added variables related to surface dipole correction [Soumya Ghosh]
     623              : ! **************************************************************************************************
     624              :    TYPE dft_control_type
     625              :       TYPE(admm_control_type), POINTER     :: admm_control => NULL()
     626              :       TYPE(period_efield_type), POINTER    :: period_efield => NULL()
     627              :       TYPE(qs_control_type), POINTER       :: qs_control => NULL()
     628              :       TYPE(rtp_control_type), POINTER      :: rtp_control => NULL()
     629              :       TYPE(sccs_control_type), POINTER     :: sccs_control => NULL()
     630              :       TYPE(tddfpt2_control_type), POINTER  :: tddfpt2_control => NULL()
     631              :       TYPE(rixs_control_type), POINTER     :: rixs_control => NULL()
     632              :       TYPE(xas_control_type), POINTER      :: xas_control => NULL()
     633              :       TYPE(expot_control_type), POINTER    :: expot_control => NULL()
     634              :       TYPE(maxwell_control_type), POINTER  :: maxwell_control => NULL()
     635              :       TYPE(smeagol_control_type), POINTER  :: smeagol_control => NULL()
     636              :       TYPE(efield_p_type), POINTER, &
     637              :          DIMENSION(:)                      :: efield_fields => NULL()
     638              :       TYPE(hairy_probes_type), POINTER, &
     639              :          DIMENSION(:)                      :: probe => NULL()
     640              :       INTEGER                              :: nspins = 0, &
     641              :                                               charge = 0, &
     642              :                                               multiplicity = 0, &
     643              :                                               sic_method_id = 0, &
     644              :                                               plus_u_method_id = 0, &
     645              :                                               dir_surf_dip = 0, &
     646              :                                               nimages = 1
     647              :       INTEGER                              :: sic_list_id = 0
     648              :       INTEGER                              :: auto_basis_ri_aux = 1, &
     649              :                                               auto_basis_aux_fit = 1, &
     650              :                                               auto_basis_lri_aux = 1, &
     651              :                                               auto_basis_p_lri_aux = 1, &
     652              :                                               auto_basis_ri_hxc = 1, &
     653              :                                               auto_basis_ri_xas = 1, &
     654              :                                               auto_basis_ri_hfx = 1
     655              :       REAL(KIND=dp)                        :: relax_multiplicity = 0.0_dp, &
     656              :                                               sic_scaling_a = 0.0_dp, &
     657              :                                               sic_scaling_b = 0.0_dp, &
     658              :                                               pos_dir_surf_dip = 0.0_dp
     659              :       LOGICAL                              :: do_xas_calculation = .FALSE., &
     660              :                                               do_xas_tdp_calculation = .FALSE., &
     661              :                                               drho_by_collocation = .FALSE., &
     662              :                                               use_kinetic_energy_density = .FALSE., &
     663              :                                               restricted = .FALSE., &
     664              :                                               roks = .FALSE., &
     665              :                                               uks = .FALSE., &
     666              :                                               lsd = .FALSE., &
     667              :                                               dft_plus_u = .FALSE., &
     668              :                                               apply_efield = .FALSE., &
     669              :                                               apply_efield_field = .FALSE., &
     670              :                                               apply_vector_potential = .FALSE., &
     671              :                                               apply_period_efield = .FALSE., &
     672              :                                               apply_external_potential = .FALSE., &
     673              :                                               eval_external_potential = .FALSE., &
     674              :                                               do_admm = .FALSE., &
     675              :                                               do_admm_dm = .FALSE., &
     676              :                                               do_admm_mo = .FALSE., &
     677              :                                               smear = .FALSE., &
     678              :                                               low_spin_roks = .FALSE., &
     679              :                                               apply_external_density = .FALSE., &
     680              :                                               read_external_density = .FALSE., &
     681              :                                               apply_external_vxc = .FALSE., &
     682              :                                               read_external_vxc = .FALSE., &
     683              :                                               correct_surf_dip = .FALSE., &
     684              :                                               surf_dip_correct_switch = .FALSE., &
     685              :                                               switch_surf_dip = .FALSE., &
     686              :                                               correct_el_density_dip = .FALSE., &
     687              :                                               do_sccs = .FALSE., &
     688              :                                               apply_embed_pot = .FALSE., &
     689              :                                               apply_dmfet_pot = .FALSE., &
     690              :                                               hairy_probes = .FALSE.
     691              :    END TYPE dft_control_type
     692              : 
     693              :    CHARACTER(len=*), PARAMETER, PRIVATE :: moduleN = 'cp_control_types'
     694              : 
     695              :    ! Public data types
     696              : 
     697              :    PUBLIC :: dft_control_type, &
     698              :              qs_control_type, &
     699              :              gapw_control_type, &
     700              :              tddfpt2_control_type, &
     701              :              rixs_control_type, &
     702              :              proj_mo_type, &
     703              :              efield_type, &
     704              :              mulliken_restraint_type, &
     705              :              ddapc_restraint_type, &
     706              :              dftb_control_type, &
     707              :              xtb_control_type, &
     708              :              semi_empirical_control_type, &
     709              :              s2_restraint_type, &
     710              :              admm_control_type, &
     711              :              maxwell_control_type, &
     712              :              expot_control_type, &
     713              :              rtp_control_type, &
     714              :              sccs_control_type, &
     715              :              stda_control_type, &
     716              :              smeared_type, &
     717              :              hairy_probes_type
     718              : 
     719              :    ! Public subroutines
     720              : 
     721              :    PUBLIC :: dft_control_release, &
     722              :              dft_control_create, &
     723              :              admm_control_create, &
     724              :              admm_control_release, &
     725              :              maxwell_control_create, &
     726              :              expot_control_create, &
     727              :              ddapc_control_create, &
     728              :              rixs_control_create, &
     729              :              rixs_control_release
     730              : 
     731              : CONTAINS
     732              : 
     733              : ! **************************************************************************************************
     734              : !> \brief create  the mulliken_restraint_type
     735              : !> \param mulliken_restraint_control ...
     736              : !> \par History
     737              : !>      02.2005 created [Joost VandeVondele]
     738              : ! **************************************************************************************************
     739         7444 :    SUBROUTINE mulliken_control_create(mulliken_restraint_control)
     740              :       TYPE(mulliken_restraint_type), INTENT(OUT)         :: mulliken_restraint_control
     741              : 
     742         7444 :       mulliken_restraint_control%strength = 0.1_dp
     743         7444 :       mulliken_restraint_control%target = 1.0_dp
     744              :       mulliken_restraint_control%natoms = 0
     745              :       NULLIFY (mulliken_restraint_control%atoms)
     746         7444 :    END SUBROUTINE mulliken_control_create
     747              : 
     748              : ! **************************************************************************************************
     749              : !> \brief release the mulliken_restraint_type
     750              : !> \param mulliken_restraint_control ...
     751              : !> \par History
     752              : !>      02.2005 created [Joost VandeVondele]
     753              : ! **************************************************************************************************
     754         7444 :    SUBROUTINE mulliken_control_release(mulliken_restraint_control)
     755              :       TYPE(mulliken_restraint_type), INTENT(INOUT)       :: mulliken_restraint_control
     756              : 
     757         7444 :       IF (ASSOCIATED(mulliken_restraint_control%atoms)) &
     758            2 :          DEALLOCATE (mulliken_restraint_control%atoms)
     759         7444 :       mulliken_restraint_control%strength = 0.0_dp
     760         7444 :       mulliken_restraint_control%target = 0.0_dp
     761         7444 :       mulliken_restraint_control%natoms = 0
     762         7444 :    END SUBROUTINE mulliken_control_release
     763              : 
     764              : ! **************************************************************************************************
     765              : !> \brief create the ddapc_restraint_type
     766              : !> \param ddapc_restraint_control ...
     767              : !> \par History
     768              : !>      02.2006 created [Joost VandeVondele]
     769              : ! **************************************************************************************************
     770           18 :    SUBROUTINE ddapc_control_create(ddapc_restraint_control)
     771              :       TYPE(ddapc_restraint_type), INTENT(OUT)            :: ddapc_restraint_control
     772              : 
     773              :       ddapc_restraint_control%density_type = do_full_density
     774           18 :       ddapc_restraint_control%strength = 0.1_dp
     775              :       ddapc_restraint_control%ddapc_order_p = 0.0_dp
     776           18 :       ddapc_restraint_control%functional_form = -1
     777           18 :       ddapc_restraint_control%target = 1.0_dp
     778              :       ddapc_restraint_control%natoms = 0
     779              :       NULLIFY (ddapc_restraint_control%atoms)
     780              :       NULLIFY (ddapc_restraint_control%coeff)
     781              : 
     782           18 :    END SUBROUTINE ddapc_control_create
     783              : 
     784              : ! **************************************************************************************************
     785              : !> \brief release the ddapc_restraint_type
     786              : !> \param ddapc_restraint_control ...
     787              : !> \par History
     788              : !>      02.2006 created [Joost VandeVondele]
     789              : ! **************************************************************************************************
     790           18 :    SUBROUTINE ddapc_control_release(ddapc_restraint_control)
     791              :       TYPE(ddapc_restraint_type), INTENT(INOUT)          :: ddapc_restraint_control
     792              : 
     793           18 :       IF (ASSOCIATED(ddapc_restraint_control%atoms)) &
     794           18 :          DEALLOCATE (ddapc_restraint_control%atoms)
     795           18 :       IF (ASSOCIATED(ddapc_restraint_control%coeff)) &
     796           18 :          DEALLOCATE (ddapc_restraint_control%coeff)
     797           18 :       ddapc_restraint_control%strength = 0.0_dp
     798           18 :       ddapc_restraint_control%target = 0.0_dp
     799           18 :       ddapc_restraint_control%natoms = 0
     800           18 :    END SUBROUTINE ddapc_control_release
     801              : 
     802              : ! **************************************************************************************************
     803              : !> \brief create the s2_restraint_type
     804              : !> \param s2_restraint_control ...
     805              : !> \par History
     806              : !>      03.2006 created [Joost VandeVondele]
     807              : ! **************************************************************************************************
     808         7444 :    SUBROUTINE s2_control_create(s2_restraint_control)
     809              :       TYPE(s2_restraint_type), INTENT(OUT)               :: s2_restraint_control
     810              : 
     811         7444 :       s2_restraint_control%strength = 0.1_dp
     812              :       s2_restraint_control%s2_order_p = 0.0_dp
     813         7444 :       s2_restraint_control%functional_form = -1
     814         7444 :       s2_restraint_control%target = 1.0_dp
     815         7444 :    END SUBROUTINE s2_control_create
     816              : 
     817              : ! **************************************************************************************************
     818              : !> \brief release the s2_restraint_type
     819              : !> \param s2_restraint_control ...
     820              : !> \par History
     821              : !>      03.2006 created [Joost VandeVondele]
     822              : ! **************************************************************************************************
     823         7444 :    SUBROUTINE s2_control_release(s2_restraint_control)
     824              :       TYPE(s2_restraint_type), INTENT(INOUT)             :: s2_restraint_control
     825              : 
     826         7444 :       s2_restraint_control%strength = 0.0_dp
     827         7444 :       s2_restraint_control%target = 0.0_dp
     828         7444 :    END SUBROUTINE s2_control_release
     829              : 
     830              : ! **************************************************************************************************
     831              : !> \brief allocates and perform a very basic initialization
     832              : !> \param dft_control the object to create
     833              : !> \par History
     834              : !>      02.2003 created [fawzi]
     835              : !> \author fawzi
     836              : ! **************************************************************************************************
     837         7444 :    SUBROUTINE dft_control_create(dft_control)
     838              :       TYPE(dft_control_type), INTENT(OUT)                :: dft_control
     839              : 
     840              :       NULLIFY (dft_control%xas_control)
     841              :       NULLIFY (dft_control%qs_control)
     842              :       NULLIFY (dft_control%tddfpt2_control)
     843              :       NULLIFY (dft_control%rixs_control)
     844              :       NULLIFY (dft_control%efield_fields)
     845              :       NULLIFY (dft_control%period_efield)
     846              :       NULLIFY (dft_control%admm_control)
     847              :       NULLIFY (dft_control%expot_control)
     848              :       NULLIFY (dft_control%maxwell_control)
     849              :       NULLIFY (dft_control%smeagol_control)
     850              :       NULLIFY (dft_control%rtp_control)
     851              :       NULLIFY (dft_control%sccs_control)
     852              :       NULLIFY (dft_control%probe)
     853              :       dft_control%do_sccs = .FALSE.
     854              :       dft_control%apply_embed_pot = .FALSE.
     855              :       dft_control%apply_dmfet_pot = .FALSE.
     856              :       dft_control%hairy_probes = .FALSE.
     857         7444 :       CALL qs_control_create(dft_control%qs_control)
     858         7444 :       CALL tddfpt2_control_create(dft_control%tddfpt2_control)
     859         7444 :       CALL rixs_control_create(dft_control%rixs_control)
     860         7444 :       CALL smeagol_control_create(dft_control%smeagol_control)
     861         7444 :    END SUBROUTINE dft_control_create
     862              : 
     863              : ! **************************************************************************************************
     864              : !> \brief ...
     865              : !> \param dft_control ...
     866              : !> \par History
     867              : !>      02.2003 created [fawzi]
     868              : !> \author fawzi
     869              : ! **************************************************************************************************
     870         7444 :    SUBROUTINE dft_control_release(dft_control)
     871              :       TYPE(dft_control_type), INTENT(INOUT)              :: dft_control
     872              : 
     873              :       INTEGER                                            :: i
     874              : 
     875         7444 :       CALL qs_control_release(dft_control%qs_control)
     876         7444 :       CALL tddfpt2_control_release(dft_control%tddfpt2_control)
     877         7444 :       CALL rixs_control_release(dft_control%rixs_control) ! maybe check first if allocated
     878         7444 :       IF (ASSOCIATED(dft_control%xas_control)) THEN
     879           42 :          CALL xas_control_release(dft_control%xas_control)
     880           42 :          DEALLOCATE (dft_control%xas_control)
     881              :       END IF
     882         7444 :       CALL admm_control_release(dft_control%admm_control)
     883         7444 :       CALL expot_control_release(dft_control%expot_control)
     884         7444 :       CALL maxwell_control_release(dft_control%maxwell_control)
     885         7444 :       CALL smeagol_control_release(dft_control%smeagol_control)
     886         7444 :       CALL efield_fields_release(dft_control%efield_fields)
     887         7444 :       IF (ASSOCIATED(dft_control%probe)) THEN
     888           12 :          DO i = 1, SIZE(dft_control%probe)
     889           12 :             DEALLOCATE (dft_control%probe(i)%atom_ids)
     890              :          END DO
     891            4 :          DEALLOCATE (dft_control%probe)
     892              :       END IF
     893         7444 :       IF (ASSOCIATED(dft_control%sccs_control)) DEALLOCATE (dft_control%sccs_control)
     894         7444 :       IF (ASSOCIATED(dft_control%period_efield)) THEN
     895           76 :          DEALLOCATE (dft_control%period_efield)
     896              :       END IF
     897         7444 :       IF (ASSOCIATED(dft_control%rtp_control)) THEN
     898          248 :          CALL proj_mo_list_release(dft_control%rtp_control%proj_mo_list)
     899          248 :          DEALLOCATE (dft_control%rtp_control)
     900              :       END IF
     901              : 
     902         7444 :    END SUBROUTINE dft_control_release
     903              : 
     904              : ! **************************************************************************************************
     905              : !> \brief ...
     906              : !> \param qs_control ...
     907              : ! **************************************************************************************************
     908         7444 :    SUBROUTINE qs_control_create(qs_control)
     909              :       TYPE(qs_control_type), POINTER                     :: qs_control
     910              : 
     911         7444 :       CPASSERT(.NOT. ASSOCIATED(qs_control))
     912        29776 :       ALLOCATE (qs_control)
     913              : 
     914              :       NULLIFY (qs_control%e_cutoff)
     915              :       NULLIFY (qs_control%gapw_control)
     916              :       NULLIFY (qs_control%mulliken_restraint_control)
     917              :       NULLIFY (qs_control%ddapc_restraint_control)
     918              :       NULLIFY (qs_control%s2_restraint_control)
     919              :       NULLIFY (qs_control%se_control)
     920              :       NULLIFY (qs_control%dftb_control)
     921              :       NULLIFY (qs_control%xtb_control)
     922              :       NULLIFY (qs_control%cdft_control)
     923              :       NULLIFY (qs_control%ddapc_restraint_control)
     924              : 
     925         7444 :       ALLOCATE (qs_control%mulliken_restraint_control)
     926         7444 :       CALL mulliken_control_create(qs_control%mulliken_restraint_control)
     927         7444 :       ALLOCATE (qs_control%s2_restraint_control)
     928         7444 :       CALL s2_control_create(qs_control%s2_restraint_control)
     929         7444 :       ALLOCATE (qs_control%gapw_control)
     930         7444 :       CALL se_control_create(qs_control%se_control)
     931         7444 :       CALL dftb_control_create(qs_control%dftb_control)
     932         7444 :       CALL xtb_control_create(qs_control%xtb_control)
     933        22332 :       ALLOCATE (qs_control%cdft_control)
     934         7444 :       CALL cdft_control_create(qs_control%cdft_control)
     935         7444 :    END SUBROUTINE qs_control_create
     936              : 
     937              : ! **************************************************************************************************
     938              : !> \brief ...
     939              : !> \param qs_control ...
     940              : ! **************************************************************************************************
     941         7444 :    SUBROUTINE qs_control_release(qs_control)
     942              :       TYPE(qs_control_type), POINTER                     :: qs_control
     943              : 
     944              :       INTEGER                                            :: i
     945              : 
     946         7444 :       IF (ASSOCIATED(qs_control)) THEN
     947         7444 :          CALL mulliken_control_release(qs_control%mulliken_restraint_control)
     948         7444 :          DEALLOCATE (qs_control%mulliken_restraint_control)
     949         7444 :          CALL s2_control_release(qs_control%s2_restraint_control)
     950         7444 :          DEALLOCATE (qs_control%s2_restraint_control)
     951         7444 :          CALL se_control_release(qs_control%se_control)
     952         7444 :          CALL dftb_control_release(qs_control%dftb_control)
     953         7444 :          CALL xtb_control_release(qs_control%xtb_control)
     954         7444 :          IF (ASSOCIATED(qs_control%cdft_control)) THEN
     955         7444 :             CALL cdft_control_release(qs_control%cdft_control)
     956         7444 :             DEALLOCATE (qs_control%cdft_control)
     957              :          END IF
     958              : 
     959         7444 :          IF (ASSOCIATED(qs_control%e_cutoff)) THEN
     960         7444 :             DEALLOCATE (qs_control%e_cutoff)
     961              :          END IF
     962         7444 :          IF (ASSOCIATED(qs_control%gapw_control)) THEN
     963         7444 :             DEALLOCATE (qs_control%gapw_control)
     964              :          END IF
     965         7444 :          IF (ASSOCIATED(qs_control%ddapc_restraint_control)) THEN
     966           32 :             DO i = 1, SIZE(qs_control%ddapc_restraint_control)
     967           32 :                CALL ddapc_control_release(qs_control%ddapc_restraint_control(i))
     968              :             END DO
     969           14 :             DEALLOCATE (qs_control%ddapc_restraint_control)
     970              :          END IF
     971         7444 :          DEALLOCATE (qs_control)
     972              :       END IF
     973         7444 :    END SUBROUTINE qs_control_release
     974              : 
     975              : ! **************************************************************************************************
     976              : !> \brief allocate control options for Time-Dependent Density Functional Theory calculation
     977              : !> \param tddfpt_control an object to create
     978              : !> \par History
     979              : !>    * 05.2016 created [Sergey Chulkov]
     980              : ! **************************************************************************************************
     981        29804 :    SUBROUTINE tddfpt2_control_create(tddfpt_control)
     982              :       TYPE(tddfpt2_control_type), POINTER                :: tddfpt_control
     983              : 
     984              :       CHARACTER(len=*), PARAMETER :: routineN = 'tddfpt2_control_create'
     985              : 
     986              :       INTEGER                                            :: handle
     987              : 
     988        14902 :       CPASSERT(.NOT. ASSOCIATED(tddfpt_control))
     989        14902 :       CALL timeset(routineN, handle)
     990              : 
     991        59608 :       ALLOCATE (tddfpt_control)
     992              :       tddfpt_control%do_soc = .FALSE.
     993              : 
     994        14902 :       CALL timestop(handle)
     995        14902 :    END SUBROUTINE tddfpt2_control_create
     996              : 
     997              : ! **************************************************************************************************
     998              : !> \brief release memory allocated for TDDFT control options
     999              : !> \param tddfpt_control an object to release
    1000              : !> \par History
    1001              : !>    * 05.2016 created [Sergey Chulkov]
    1002              : ! **************************************************************************************************
    1003        14902 :    SUBROUTINE tddfpt2_control_release(tddfpt_control)
    1004              :       TYPE(tddfpt2_control_type), POINTER                :: tddfpt_control
    1005              : 
    1006              :       CHARACTER(len=*), PARAMETER :: routineN = 'tddfpt2_control_release'
    1007              : 
    1008              :       INTEGER                                            :: handle
    1009              : 
    1010        14902 :       CALL timeset(routineN, handle)
    1011              : 
    1012        14902 :       IF (ASSOCIATED(tddfpt_control)) THEN
    1013        14902 :          DEALLOCATE (tddfpt_control)
    1014              :       END IF
    1015              : 
    1016        14902 :       CALL timestop(handle)
    1017        14902 :    END SUBROUTINE tddfpt2_control_release
    1018              : 
    1019              : ! **************************************************************************************************
    1020              : !> \brief Creates and initializes the rixs_control_type
    1021              : !> \param rixs_control the type to initialize
    1022              : ! **************************************************************************************************
    1023         7458 :    SUBROUTINE rixs_control_create(rixs_control)
    1024              :       TYPE(rixs_control_type), POINTER                   :: rixs_control
    1025              : 
    1026         7458 :       CPASSERT(.NOT. ASSOCIATED(rixs_control))
    1027         7458 :       ALLOCATE (rixs_control)
    1028              : 
    1029              :       NULLIFY (rixs_control%tddfpt2_control)
    1030         7458 :       CALL tddfpt2_control_create(rixs_control%tddfpt2_control)
    1031         7458 :       NULLIFY (rixs_control%xas_tdp_control)
    1032         7458 :       CALL xas_tdp_control_create(rixs_control%xas_tdp_control)
    1033              : 
    1034         7458 :    END SUBROUTINE rixs_control_create
    1035              : 
    1036              : ! **************************************************************************************************
    1037              : !> \brief Releases the rixs_control_type
    1038              : !> \param rixs_control ...
    1039              : ! **************************************************************************************************
    1040         7458 :    SUBROUTINE rixs_control_release(rixs_control)
    1041              :       TYPE(rixs_control_type), POINTER                   :: rixs_control
    1042              : 
    1043         7458 :       IF (ASSOCIATED(rixs_control)) THEN
    1044         7458 :          CALL tddfpt2_control_release(rixs_control%tddfpt2_control)
    1045         7458 :          CALL xas_tdp_control_release(rixs_control%xas_tdp_control)
    1046              : 
    1047         7458 :          DEALLOCATE (rixs_control)
    1048              :       END IF
    1049              : 
    1050         7458 :    END SUBROUTINE rixs_control_release
    1051              : 
    1052              : ! **************************************************************************************************
    1053              : !> \brief ...
    1054              : !> \param proj_mo_list ...
    1055              : ! **************************************************************************************************
    1056          248 :    SUBROUTINE proj_mo_list_release(proj_mo_list)
    1057              :       TYPE(proj_mo_p_type), DIMENSION(:), POINTER        :: proj_mo_list
    1058              : 
    1059              :       INTEGER                                            :: i, mo_ref_nbr
    1060              : 
    1061          248 :       IF (ASSOCIATED(proj_mo_list)) THEN
    1062           56 :          DO i = 1, SIZE(proj_mo_list)
    1063           56 :             IF (ASSOCIATED(proj_mo_list(i)%proj_mo)) THEN
    1064           52 :                IF (ALLOCATED(proj_mo_list(i)%proj_mo%ref_mo_index)) &
    1065           52 :                   DEALLOCATE (proj_mo_list(i)%proj_mo%ref_mo_index)
    1066           52 :                IF (ALLOCATED(proj_mo_list(i)%proj_mo%mo_ref)) THEN
    1067          204 :                   DO mo_ref_nbr = 1, SIZE(proj_mo_list(i)%proj_mo%mo_ref)
    1068          204 :                      CALL cp_fm_release(proj_mo_list(i)%proj_mo%mo_ref(mo_ref_nbr))
    1069              :                   END DO
    1070           52 :                   DEALLOCATE (proj_mo_list(i)%proj_mo%mo_ref)
    1071              :                END IF
    1072           52 :                IF (ALLOCATED(proj_mo_list(i)%proj_mo%td_mo_index)) &
    1073           52 :                   DEALLOCATE (proj_mo_list(i)%proj_mo%td_mo_index)
    1074           52 :                IF (ALLOCATED(proj_mo_list(i)%proj_mo%td_mo_occ)) &
    1075           52 :                   DEALLOCATE (proj_mo_list(i)%proj_mo%td_mo_occ)
    1076           52 :                DEALLOCATE (proj_mo_list(i)%proj_mo)
    1077              :             END IF
    1078              :          END DO
    1079            4 :          DEALLOCATE (proj_mo_list)
    1080              :       END IF
    1081          248 :    END SUBROUTINE proj_mo_list_release
    1082              : 
    1083              : ! **************************************************************************************************
    1084              : !> \brief ...
    1085              : !> \param efield_fields ...
    1086              : ! **************************************************************************************************
    1087         7444 :    SUBROUTINE efield_fields_release(efield_fields)
    1088              :       TYPE(efield_p_type), DIMENSION(:), POINTER         :: efield_fields
    1089              : 
    1090              :       INTEGER                                            :: i
    1091              : 
    1092         7444 :       IF (ASSOCIATED(efield_fields)) THEN
    1093          524 :          DO i = 1, SIZE(efield_fields)
    1094          524 :             IF (ASSOCIATED(efield_fields(i)%efield)) THEN
    1095          262 :                IF (ASSOCIATED(efield_fields(i)%efield%envelop_r_vars)) THEN
    1096            8 :                   DEALLOCATE (efield_fields(i)%efield%envelop_r_vars)
    1097              :                END IF
    1098          262 :                IF (ASSOCIATED(efield_fields(i)%efield%envelop_i_vars)) THEN
    1099          254 :                   DEALLOCATE (efield_fields(i)%efield%envelop_i_vars)
    1100              :                END IF
    1101          262 :                IF (ASSOCIATED(efield_fields(i)%efield%polarisation)) &
    1102          262 :                   DEALLOCATE (efield_fields(i)%efield%polarisation)
    1103          262 :                DEALLOCATE (efield_fields(i)%efield)
    1104              :             END IF
    1105              :          END DO
    1106          262 :          DEALLOCATE (efield_fields)
    1107              :       END IF
    1108         7444 :    END SUBROUTINE efield_fields_release
    1109              : 
    1110              : ! **************************************************************************************************
    1111              : !> \brief ...
    1112              : !> \param dftb_control ...
    1113              : ! **************************************************************************************************
    1114         7444 :    SUBROUTINE dftb_control_create(dftb_control)
    1115              :       TYPE(dftb_control_type), POINTER                   :: dftb_control
    1116              : 
    1117         7444 :       CPASSERT(.NOT. ASSOCIATED(dftb_control))
    1118        74440 :       ALLOCATE (dftb_control)
    1119              : 
    1120              :       NULLIFY (dftb_control%sk_pair_list)
    1121         7444 :    END SUBROUTINE dftb_control_create
    1122              : 
    1123              : ! **************************************************************************************************
    1124              : !> \brief ...
    1125              : !> \param dftb_control ...
    1126              : ! **************************************************************************************************
    1127         7444 :    SUBROUTINE dftb_control_release(dftb_control)
    1128              :       TYPE(dftb_control_type), POINTER                   :: dftb_control
    1129              : 
    1130         7444 :       IF (ASSOCIATED(dftb_control)) THEN
    1131         7444 :          IF (ASSOCIATED(dftb_control%sk_pair_list)) THEN
    1132          222 :             DEALLOCATE (dftb_control%sk_pair_list)
    1133              :          END IF
    1134         7444 :          DEALLOCATE (dftb_control)
    1135              :       END IF
    1136         7444 :    END SUBROUTINE dftb_control_release
    1137              : 
    1138              : ! **************************************************************************************************
    1139              : !> \brief ...
    1140              : !> \param xtb_control ...
    1141              : ! **************************************************************************************************
    1142         7444 :    SUBROUTINE xtb_control_create(xtb_control)
    1143              :       TYPE(xtb_control_type), POINTER                    :: xtb_control
    1144              : 
    1145         7444 :       CPASSERT(.NOT. ASSOCIATED(xtb_control))
    1146         7444 :       ALLOCATE (xtb_control)
    1147              : 
    1148              :       NULLIFY (xtb_control%kab_param)
    1149              :       NULLIFY (xtb_control%kab_vals)
    1150              :       NULLIFY (xtb_control%kab_types)
    1151              :       NULLIFY (xtb_control%nonbonded)
    1152              :       NULLIFY (xtb_control%rcpair)
    1153              : 
    1154         7444 :    END SUBROUTINE xtb_control_create
    1155              : 
    1156              : ! **************************************************************************************************
    1157              : !> \brief ...
    1158              : !> \param xtb_control ...
    1159              : ! **************************************************************************************************
    1160         7444 :    SUBROUTINE xtb_control_release(xtb_control)
    1161              :       TYPE(xtb_control_type), POINTER                    :: xtb_control
    1162              : 
    1163         7444 :       IF (ASSOCIATED(xtb_control)) THEN
    1164         7444 :          IF (ASSOCIATED(xtb_control%kab_param)) THEN
    1165            2 :             DEALLOCATE (xtb_control%kab_param)
    1166              :          END IF
    1167         7444 :          IF (ASSOCIATED(xtb_control%kab_vals)) THEN
    1168            2 :             DEALLOCATE (xtb_control%kab_vals)
    1169              :          END IF
    1170         7444 :          IF (ASSOCIATED(xtb_control%kab_types)) THEN
    1171            2 :             DEALLOCATE (xtb_control%kab_types)
    1172              :          END IF
    1173         7444 :          IF (ASSOCIATED(xtb_control%rcpair)) THEN
    1174          944 :             DEALLOCATE (xtb_control%rcpair)
    1175              :          END IF
    1176         7444 :          IF (ASSOCIATED(xtb_control%nonbonded)) THEN
    1177            6 :             CALL pair_potential_p_release(xtb_control%nonbonded)
    1178              :          END IF
    1179         7444 :          DEALLOCATE (xtb_control)
    1180              :       END IF
    1181         7444 :    END SUBROUTINE xtb_control_release
    1182              : 
    1183              : ! **************************************************************************************************
    1184              : !> \brief ...
    1185              : !> \param se_control ...
    1186              : ! **************************************************************************************************
    1187         7444 :    SUBROUTINE se_control_create(se_control)
    1188              :       TYPE(semi_empirical_control_type), POINTER         :: se_control
    1189              : 
    1190         7444 :       CPASSERT(.NOT. ASSOCIATED(se_control))
    1191        37220 :       ALLOCATE (se_control)
    1192         7444 :    END SUBROUTINE se_control_create
    1193              : 
    1194              : ! **************************************************************************************************
    1195              : !> \brief ...
    1196              : !> \param se_control ...
    1197              : ! **************************************************************************************************
    1198         7444 :    SUBROUTINE se_control_release(se_control)
    1199              :       TYPE(semi_empirical_control_type), POINTER         :: se_control
    1200              : 
    1201         7444 :       IF (ASSOCIATED(se_control)) THEN
    1202         7444 :          DEALLOCATE (se_control)
    1203              :       END IF
    1204         7444 :    END SUBROUTINE se_control_release
    1205              : 
    1206              : ! **************************************************************************************************
    1207              : !> \brief ...
    1208              : !> \param admm_control ...
    1209              : ! **************************************************************************************************
    1210          464 :    SUBROUTINE admm_control_create(admm_control)
    1211              :       TYPE(admm_control_type), POINTER                   :: admm_control
    1212              : 
    1213          464 :       CPASSERT(.NOT. ASSOCIATED(admm_control))
    1214         2320 :       ALLOCATE (admm_control)
    1215              : 
    1216          464 :    END SUBROUTINE admm_control_create
    1217              : 
    1218              : ! **************************************************************************************************
    1219              : !> \brief ...
    1220              : !> \param admm_control ...
    1221              : ! **************************************************************************************************
    1222         7448 :    SUBROUTINE admm_control_release(admm_control)
    1223              :       TYPE(admm_control_type), POINTER                   :: admm_control
    1224              : 
    1225         7448 :       IF (ASSOCIATED(admm_control)) THEN
    1226          504 :          DEALLOCATE (admm_control)
    1227              :       END IF
    1228         7448 :    END SUBROUTINE admm_control_release
    1229              : 
    1230              : ! **************************************************************************************************
    1231              : !> \brief ...
    1232              : !> \param expot_control ...
    1233              : ! **************************************************************************************************
    1234           16 :    SUBROUTINE expot_control_create(expot_control)
    1235              :       TYPE(expot_control_type), POINTER                  :: expot_control
    1236              : 
    1237           16 :       CPASSERT(.NOT. ASSOCIATED(expot_control))
    1238           16 :       ALLOCATE (expot_control)
    1239              :       expot_control%read_from_cube = .FALSE.
    1240              :       expot_control%maxwell_solver = .FALSE.
    1241           16 :       expot_control%static = .TRUE.
    1242           16 :       expot_control%scaling_factor = 1.0_dp
    1243              : 
    1244           16 :    END SUBROUTINE expot_control_create
    1245              : 
    1246              : ! **************************************************************************************************
    1247              : !> \brief ...
    1248              : !> \param expot_control ...
    1249              : ! **************************************************************************************************
    1250         7444 :    SUBROUTINE expot_control_release(expot_control)
    1251              :       TYPE(expot_control_type), POINTER                  :: expot_control
    1252              : 
    1253         7444 :       IF (ASSOCIATED(expot_control)) THEN
    1254           16 :          DEALLOCATE (expot_control)
    1255              :       END IF
    1256              : 
    1257         7444 :    END SUBROUTINE expot_control_release
    1258              : 
    1259              : ! **************************************************************************************************
    1260              : !> \brief ...
    1261              : !> \param maxwell_control ...
    1262              : ! **************************************************************************************************
    1263            0 :    SUBROUTINE maxwell_control_create(maxwell_control)
    1264              :       TYPE(maxwell_control_type), POINTER                :: maxwell_control
    1265              : 
    1266            0 :       CPASSERT(.NOT. ASSOCIATED(maxwell_control))
    1267            0 :       ALLOCATE (maxwell_control)
    1268              : 
    1269            0 :    END SUBROUTINE maxwell_control_create
    1270              : 
    1271              : ! **************************************************************************************************
    1272              : !> \brief ...
    1273              : !> \param maxwell_control ...
    1274              : ! **************************************************************************************************
    1275         7444 :    SUBROUTINE maxwell_control_release(maxwell_control)
    1276              :       TYPE(maxwell_control_type), POINTER                :: maxwell_control
    1277              : 
    1278         7444 :       IF (ASSOCIATED(maxwell_control)) THEN
    1279            0 :          DEALLOCATE (maxwell_control)
    1280              :       END IF
    1281              : 
    1282         7444 :    END SUBROUTINE maxwell_control_release
    1283              : 
    1284            0 : END MODULE cp_control_types
        

Generated by: LCOV version 2.0-1