Difference between revisions of "Explanations for C2H2 gs input files"
Line 10: | Line 10: | ||
If you do not specify the units for some physical quantities, atomic unit will be used for those quantities. | If you do not specify the units for some physical quantities, atomic unit will be used for those quantities. | ||
− | == &calculation(Mandatory: | + | == &calculation(Mandatory: calc_mode) == |
&calculation | &calculation | ||
Line 29: | Line 29: | ||
/ | / | ||
− | domain_parallel = 'y' indicates that the spatial grid is divided and parallely executed. | + | <code>domain_parallel = 'y'</code> indicates that the spatial grid is divided and parallely executed. |
− | nproc_ob = 1 indicates the number of MPI parallelization for orbitals. | + | <code>nproc_ob = 1</code> indicates the number of MPI parallelization for orbitals. |
− | nproc_domain = 3,4,1 indicates the spatial division for orbitals in x,y,z directions. | + | <code>nproc_domain = 3,4,1</code> indicates the spatial division for orbitals in x,y,z directions. |
− | nproc_domain_s = 3,4,1 indicates the spatial divisions for Hartree potential in x,y,z directions. | + | <code>nproc_domain_s = 3,4,1</code> indicates the spatial divisions for Hartree potential in x,y,z directions. |
== &system(Mandatory: iperiodic, al, nstate, nelem, natom) == | == &system(Mandatory: iperiodic, al, nstate, nelem, natom) == | ||
Line 45: | Line 45: | ||
/ | / | ||
− | iperiodic = 0 indicates that isolated boundary condition is assumed. | + | <code>iperiodic = 0</code> indicates that isolated boundary condition is assumed. |
− | al = 16d0, 16d0, 16d0 specifies the lengths of three sides of a rectangular parallelepiped where the grid points are prepared. | + | <code>al = 16d0, 16d0, 16d0</code> specifies the lengths of three sides of a rectangular parallelepiped where the grid points are prepared. |
− | nstate = 5 indicates the number of Kohn-Sham orbitals to be solved. | + | <code>nstate = 5</code> indicates the number of Kohn-Sham orbitals to be solved. |
− | nelem = 2 and natom = 4 indicate the number of elements and the number of atoms in the system, respectively. ` | + | <code>nelem = 2</code> and <code>natom = 4</code> indicate the number of elements and the number of atoms in the system, respectively. ` |
− | file_atom='coo.dat' indicates that the atomic positions of the molecule is provided by the file coo.dat. | + | <code>file_atom='coo.dat'</code> indicates that the atomic positions of the molecule is provided by the file <code>coo.dat</code>. |
− | The atomic positions may be specified in the &atomic_positions of the input file. | + | The atomic positions may be specified in the <code>&atomic_positions</code> of the input file. |
== &pseudo(Mandatory: pseudo_file, iZatom) == | == &pseudo(Mandatory: pseudo_file, iZatom) == | ||
Line 65: | Line 65: | ||
/ | / | ||
− | Information on pseudopotentials. pseudo_file(1) = indicates the filename of the pseudopotential of element 1. | + | Information on pseudopotentials. <code>pseudo_file(1) = 'file_pseudo.dat'</code> indicates the filename of the pseudopotential of element 1. |
− | Lmax_ps(1) = and Lloc_ps(1) = indicate the maximum angular momentum of the pseudopotential projector and the angular momentum of the pseudopotential that will be treated as local, respectively. | + | <code>Lmax_ps(1) = 1</code> and <code>Lloc_ps(1) = 1</code> indicate the maximum angular momentum of the pseudopotential projector and the angular momentum of the pseudopotential that will be treated as local, respectively. |
− | iZatom(1) = indicates the atomic number of the element 1. | + | <code>iZatom(1) = 6</code> indicates the atomic number of the element 1. |
== &rgrid(Mandatory: {dl,num_rgrid}) == | == &rgrid(Mandatory: {dl,num_rgrid}) == | ||
Line 75: | Line 75: | ||
/ | / | ||
− | dl = 0.25d0, 0.25d0, 0.25d0 specifies grid spacing in three Cartesian directions. | + | <code>dl = 0.25d0, 0.25d0, 0.25d0</code> specifies grid spacing in three Cartesian directions. |
The grid spacing can also be specified by num_rgrid that specifies the number of grid points. | The grid spacing can also be specified by num_rgrid that specifies the number of grid points. | ||
Revision as of 12:43, 11 June 2017
Contents
- 1 &unit(Mandatory: none)
- 2 &calculation(Mandatory: calc_mode)
- 3 ¶llel(Mandatory: none?)
- 4 &system(Mandatory: iperiodic, al, nstate, nelem, natom)
- 5 &pseudo(Mandatory: pseudo_file, iZatom)
- 6 &rgrid(Mandatory: {dl,num_rgrid})
- 7 &scf(Mandatory: nscf)
- 8 &hartree(Mandatory: none)
- 9 &group_fundamental(Mandatory: ?)
- 10 &group_file(Mandatory: file_OUT)
&unit(Mandatory: none)
&units unit_length='Angstrom' unit_energy='eV' unit_time='fs' /
This namelist specifies the unit system used in the input and the output files. If you do not specify the units for some physical quantities, atomic unit will be used for those quantities.
&calculation(Mandatory: calc_mode)
&calculation calc_mode = 'GS' /
The variable calc_mode
should be one of 'GS'
, 'RT'
, and 'GS-RT'
.
Note that the ground state ('GS'
) and real time ('RT'
) calculations should be done separately and sequentially for isolated systems (specified by iperiodic = 0
in &system
).
For periodic systems (specified by iperiodic = 3
in &system
), both ground state and real time calculations should be carried out as a single task (calc_mode = 'GS_RT'
).
¶llel(Mandatory: none?)
¶llel domain_parallel = 'y' nproc_ob = 1 nproc_domain = 3,4,1 nproc_domain_s = 3,4,1 /
domain_parallel = 'y'
indicates that the spatial grid is divided and parallely executed.
nproc_ob = 1
indicates the number of MPI parallelization for orbitals.
nproc_domain = 3,4,1
indicates the spatial division for orbitals in x,y,z directions.
nproc_domain_s = 3,4,1
indicates the spatial divisions for Hartree potential in x,y,z directions.
&system(Mandatory: iperiodic, al, nstate, nelem, natom)
&system iperiodic = 0 al = 16d0, 16d0, 16d0 nstate = 5 nelem = 2 natom = 4 file_atom='coo.data' /
iperiodic = 0
indicates that isolated boundary condition is assumed.
al = 16d0, 16d0, 16d0
specifies the lengths of three sides of a rectangular parallelepiped where the grid points are prepared.
nstate = 5
indicates the number of Kohn-Sham orbitals to be solved.
nelem = 2
and natom = 4
indicate the number of elements and the number of atoms in the system, respectively. `
file_atom='coo.dat'
indicates that the atomic positions of the molecule is provided by the file coo.dat
.
The atomic positions may be specified in the &atomic_positions
of the input file.
&pseudo(Mandatory: pseudo_file, iZatom)
&pseudo iZatom(1)=6 iZatom(2)=1 ps_format(1)='KY' ps_format(2)='KY' Lmax_ps(1)=1 Lmax_ps(2)=0 Lloc_ps(1)=1 Lloc_ps(2)=0 /
Information on pseudopotentials. pseudo_file(1) = 'file_pseudo.dat'
indicates the filename of the pseudopotential of element 1.
Lmax_ps(1) = 1
and Lloc_ps(1) = 1
indicate the maximum angular momentum of the pseudopotential projector and the angular momentum of the pseudopotential that will be treated as local, respectively.
iZatom(1) = 6
indicates the atomic number of the element 1.
&rgrid(Mandatory: {dl,num_rgrid})
&rgrid dl = 0.25d0, 0.25d0, 0.25d0 /
dl = 0.25d0, 0.25d0, 0.25d0
specifies grid spacing in three Cartesian directions.
The grid spacing can also be specified by num_rgrid that specifies the number of grid points.
&scf(Mandatory: nscf)
&scf rmixrate = 0.1d0 ncg = 4 nscf = 1000 /
Nscf specifies the number of SCF iterations.
&hartree(Mandatory: none)
&hartree meo = 3 num_pole_xyz = 2,2,2 /
meo = 3 specifies the order of multipole expansion of electron density that is used to prepare boundary condition for the Hartree potential.
&group_fundamental(Mandatory: ?)
&group_fundamental MST(1)=5 ifMST(1)=5 /
&group_file(Mandatory: file_OUT)
&group_file file_OUT='C2H2.data' LDA_Info='C2H2.info' /
The file C2H2.data specified in file_OUT='C2H2.data' will be used as input in the real time calculation.
- Real-time electron dynamics calculation for ethylene
- `&unit`(*Mandatory*: none) ``` &units
unit_length='Angstrom' unit_energy='eV' unit_time='fs'
/ ``` This namelist specifies the unit system used in the input and the output files. If you do not specify the units for some physical quantities, atomic unit will be used for those quantities.
- `&calculation`(*Mandatory*: calc_mode) ``` &calculation
calc_mode = 'RT'
/ ``` The variable `calc_mode` should be one of `'GS'`, `'RT'`, and `'GS-RT'`. Note that the ground state (GS) and real time (RT) calculations should be done separately and sequentially for isolated systems (specified by `iperiodic = 0` in `&system`). For periodic systems (specified by `iperiodic = 3` in `&system`), both ground state and real time calculations should be carried out as a single task (`calc_mode = 'GS_RT'`).
- `¶llel`(*Mandatory*: none?) ``` ¶llel
domain_parallel = 'y' nproc_ob = 1 nproc_domain = 1,1,1 nproc_domain_s = 1,1,1
/ ``` `domain_parallel = 'y'` indicates that the spatial grid is divided and parallely executed. 'nproc_ob = 1' indicates the number of MPI parallelization for orbitals. 'nproc_domain = 1,1,1' indicates the spatial division for orbitals in x,y,z directions. `nproc_domain_s = 1,1,1` indicates the spatial divisions for Hartree potential in x,y,z directions.
- `&tgrid`(*Mandatory*: dt, Nt) ``` &tgrid
dt=1.25d-3 Nt=24000
/ ``` `dt=1.25d-3` specifies the time step for the time evolution. For a stable time evolution, there is a certain upper limit for *dt*. If one decreases the grid spacing by a factor *a*, *dt* should be decreased by a factor of *axa*. `Nt` specifies the number of time steps.
- `&emfield`(*Mandatory*: ae_shape1,epdir_re1,{rlaser_int1, amplitude1},omega1,pulse_tw1, phi_cep1) ``` &emfield
ae_shape1 = 'esin2cos' epdir_re1 = 0.d0,0.d0,1.d0 epdir_re2 = 0.d0,0.d0,0.d0 rlaser_int1 = 1.d8 rlaser_int2 = 0.d0 omega1=9.26d0 pulse_tw1=30.d0 phi_cep1=0.75d0
/ ``` `ae_shape1 = 'esin2cos'` specifies the envelope function. Possible options for the pulse shape is *esin2cos*, *asin2cos*. The first letter 'a' or 'e' indicates that the envelope function is prepared for vector potential or electric field, respectively. `epdir_re1 = 0.d0,0.d0,1.d0` and `epdir_im1 = 0.d0,0.d0,0.d0` specify real and imaginary parts of the polarization vector, respectively. `rlaser_int1 = 1.d8` specifies the maximum laser intensity in unit of W/cm^2. `omega=9.26d0` specifies the average frequency of the laser pulse. `pulse_tw1=30.d0` specifies the pulse duration. Note that it is not a FWHM value but a whole period from the start to the end. `phi_cep1=0.75d0` specifies the carrier envelope phase. Parameters for two pulse can be specified, including the time delay between two pulses using a variable `T1_T2`.
- `&hartree`(*Mandatory*: none) ``` &hartree
meo = 3 num_pole_xyz = 2,2,2
/ ``` `meo = 3` specifies the order of multipole expansion of electron density that is used to prepare boundary condition for the Hartree potential.
- `&group_file`(*Mandatory*: file_IN, file_RT) ``` &group_file file_IN='C2H2.data' file_RT='C2H2-RT.data' file_alpha='C2H2-ALP.data' / ``` `file_IN='C2H2.data'` specifies the filename of the ground state calculation that is required before starting this real time calculation.