►Ndetail | Detail namespace with internal helper functions |
►Ncontainer_input_adapter_factory_impl | |
Ccontainer_input_adapter_factory | |
Ccontainer_input_adapter_factory< ContainerType, void_t< decltype(begin(std::declval< ContainerType >()), end(std::declval< ContainerType >()))> > | |
►Ndtoa_impl | Implements the Grisu2 algorithm for binary to decimal floating-point conversion |
Cboundaries | |
Ccached_power | |
Cdiyfp | |
►Nutility_internal | |
CExtend | |
CExtend< integer_sequence< T, Ints... >, SeqSize, 0 > | |
CExtend< integer_sequence< T, Ints... >, SeqSize, 1 > | |
CGen | |
CGen< T, 0 > | |
Cactual_object_comparator | |
Cbinary_reader | Deserialization of CBOR, MessagePack, and UBJSON values |
Cbinary_writer | Serialization to CBOR and MessagePack values |
Cconjunction | |
Cconjunction< B > | |
Cconjunction< B, Bn... > | |
Cdetector | |
Cdetector< Default, void_t< Op< Args... > >, Op, Args... > | |
Cexception | General exception of the basic_json class |
Cexternal_constructor | |
Cexternal_constructor< value_t::array > | |
Cexternal_constructor< value_t::binary > | |
Cexternal_constructor< value_t::boolean > | |
Cexternal_constructor< value_t::number_float > | |
Cexternal_constructor< value_t::number_integer > | |
Cexternal_constructor< value_t::number_unsigned > | |
Cexternal_constructor< value_t::object > | |
Cexternal_constructor< value_t::string > | |
Cfile_input_adapter | |
Cfrom_json_fn | |
Chas_from_json | |
Chas_from_json< BasicJsonType, T, enable_if_t< !is_basic_json< T >::value > > | |
Chas_key_compare | |
Chas_non_default_from_json | |
Chas_non_default_from_json< BasicJsonType, T, enable_if_t< !is_basic_json< T >::value > > | |
Chas_to_json | |
Chas_to_json< BasicJsonType, T, enable_if_t< !is_basic_json< T >::value > > | |
Cidentity_tag | |
Cinput_stream_adapter | |
Cinteger_sequence | |
Cinternal_iterator | Iterator value |
Cinvalid_iterator | Exception indicating errors with iterators |
Cis_basic_json | |
Cis_basic_json< NLOHMANN_BASIC_JSON_TPL > | |
Cis_basic_json_context | |
Cis_c_string | |
Cis_comparable | |
Cis_comparable< Compare, A, B, void_t< decltype(std::declval< Compare >()(std::declval< A >(), std::declval< B >())), decltype(std::declval< Compare >()(std::declval< B >(), std::declval< A >()))> > | |
Cis_compatible_array_type | |
Cis_compatible_array_type_impl | |
Cis_compatible_array_type_impl< BasicJsonType, CompatibleArrayType, enable_if_t< is_detected< iterator_t, CompatibleArrayType >::value &&is_iterator_traits< iterator_traits< detected_t< iterator_t, CompatibleArrayType > > >::value &&!std::is_same< CompatibleArrayType, detected_t< range_value_t, CompatibleArrayType > >::value > > | |
Cis_compatible_integer_type | |
Cis_compatible_integer_type_impl | |
Cis_compatible_integer_type_impl< RealIntegerType, CompatibleNumberIntegerType, enable_if_t< std::is_integral< RealIntegerType >::value &&std::is_integral< CompatibleNumberIntegerType >::value &&!std::is_same< bool, CompatibleNumberIntegerType >::value > > | |
Cis_compatible_object_type | |
Cis_compatible_object_type_impl | |
Cis_compatible_object_type_impl< BasicJsonType, CompatibleObjectType, enable_if_t< is_detected< mapped_type_t, CompatibleObjectType >::value &&is_detected< key_type_t, CompatibleObjectType >::value > > | |
Cis_compatible_string_type | |
Cis_compatible_type | |
Cis_compatible_type_impl | |
Cis_compatible_type_impl< BasicJsonType, CompatibleType, enable_if_t< is_complete_type< CompatibleType >::value > > | |
Cis_complete_type | |
Cis_complete_type< T, decltype(void(sizeof(T)))> | |
Cis_constructible | |
Cis_constructible< const std::pair< T1, T2 > > | |
Cis_constructible< const std::tuple< Ts... > > | |
Cis_constructible< std::pair< T1, T2 > > | |
Cis_constructible< std::tuple< Ts... > > | |
Cis_constructible_array_type | |
Cis_constructible_array_type_impl | |
Cis_constructible_array_type_impl< BasicJsonType, ConstructibleArrayType, enable_if_t< !std::is_same< ConstructibleArrayType, typename BasicJsonType::value_type >::value &&!is_compatible_string_type< BasicJsonType, ConstructibleArrayType >::value &&is_default_constructible< ConstructibleArrayType >::value &&(std::is_move_assignable< ConstructibleArrayType >::value||std::is_copy_assignable< ConstructibleArrayType >::value)&&is_detected< iterator_t, ConstructibleArrayType >::value &&is_iterator_traits< iterator_traits< detected_t< iterator_t, ConstructibleArrayType > > >::value &&is_detected< range_value_t, ConstructibleArrayType >::value &&!std::is_same< ConstructibleArrayType, detected_t< range_value_t, ConstructibleArrayType > >::value &&is_complete_type< detected_t< range_value_t, ConstructibleArrayType > >::value > > | |
Cis_constructible_array_type_impl< BasicJsonType, ConstructibleArrayType, enable_if_t< std::is_same< ConstructibleArrayType, typename BasicJsonType::value_type >::value > > | |
Cis_constructible_object_type | |
Cis_constructible_object_type_impl | |
Cis_constructible_object_type_impl< BasicJsonType, ConstructibleObjectType, enable_if_t< is_detected< mapped_type_t, ConstructibleObjectType >::value &&is_detected< key_type_t, ConstructibleObjectType >::value > > | |
Cis_constructible_string_type | |
Cis_constructible_tuple | |
Cis_constructible_tuple< T1, std::tuple< Args... > > | |
Cis_default_constructible | |
Cis_default_constructible< const std::pair< T1, T2 > > | |
Cis_default_constructible< const std::tuple< Ts... > > | |
Cis_default_constructible< std::pair< T1, T2 > > | |
Cis_default_constructible< std::tuple< Ts... > > | |
Cis_detected_lazy | |
Cis_getable | |
Cis_iterator_of_multibyte | |
Cis_iterator_traits | |
Cis_iterator_traits< iterator_traits< T > > | |
Cis_json_iterator_of | |
Cis_json_iterator_of< BasicJsonType, typename BasicJsonType::const_iterator > | |
Cis_json_iterator_of< BasicJsonType, typename BasicJsonType::iterator > | |
Cis_json_ref | |
Cis_json_ref< json_ref< T > > | |
►Cis_ordered_map | |
Ctwo | |
Cis_range | |
Cis_sax | |
Cis_sax_static_asserts | |
Cis_specialization_of | |
Cis_specialization_of< Primary, Primary< Args... > > | |
Cis_transparent | |
Citer_impl | Template for a bidirectional iterator for the basic_json class This class implements a both iterators (iterator and const_iterator) for the basic_json class |
Citeration_proxy | Proxy class for the items() function |
Citeration_proxy_value | |
Citerator_input_adapter | |
Citerator_input_adapter_factory | |
Citerator_input_adapter_factory< IteratorType, enable_if_t< is_iterator_of_multibyte< IteratorType >::value > > | |
Citerator_traits | |
Citerator_traits< T *, enable_if_t< std::is_object< T >::value > > | |
Citerator_traits< T, enable_if_t< !std::is_pointer< T >::value > > | |
Citerator_types | |
Citerator_types< It, void_t< typename It::difference_type, typename It::value_type, typename It::pointer, typename It::reference, typename It::iterator_category > > | |
Cjson_default_base | Default base class of the basic_json class |
Cjson_ref | |
Cjson_reverse_iterator | Template for a reverse iterator class |
Cjson_sax_acceptor | |
Cjson_sax_dom_callback_parser | |
Cjson_sax_dom_parser | SAX implementation to create a JSON value from SAX events |
Clexer | Lexical analysis |
Clexer_base | |
Cmake_void | |
Cnegation | |
Cnonesuch | |
Cother_error | Exception indicating other library errors |
Cout_of_range | Exception indicating access out of the defined range |
Coutput_adapter | |
Coutput_adapter_protocol | Abstract output adapter interface |
Coutput_stream_adapter | Output adapter for output streams |
Coutput_string_adapter | Output adapter for basic_string |
Coutput_vector_adapter | Output adapter for byte vectors |
Cparse_error | Exception indicating a parse error |
Cparser | Syntax analysis |
Cposition_t | Struct to capture the start position of the current token |
Cprimitive_iterator_t | |
Cpriority_tag | |
Cpriority_tag< 0 > | |
Cserializer | |
Cspan_input_adapter | |
Cstatic_const | |
Cto_json_fn | |
Ctype_error | Exception indicating executing a member function with a wrong type |
Cvalue_in_range_of_impl1 | |
Cvalue_in_range_of_impl1< OfType, T, false > | |
Cvalue_in_range_of_impl1< OfType, T, true > | |
Cvalue_in_range_of_impl2 | |
Cvalue_in_range_of_impl2< OfType, T, false, false > | |
Cvalue_in_range_of_impl2< OfType, T, false, true > | |
Cvalue_in_range_of_impl2< OfType, T, true, false > | |
Cvalue_in_range_of_impl2< OfType, T, true, true > | |
Cwide_string_input_adapter | |
Cwide_string_input_helper | |
Cwide_string_input_helper< BaseInputAdapter, 2 > | |
Cwide_string_input_helper< BaseInputAdapter, 4 > | |
►Nrt_graph | |
►Ninternal | |
CTimeStamp | |
CTimingNode | |
CScopedTiming | |
CTimer | |
CTimingResult | |
►Nsirius | Namespace of the SIRIUS library |
►Nacc | Namespace for accelerator-related functions |
►Ncusolver | Interface to cuSolver library |
Ctype_wrapper | |
Ctype_wrapper< double > | |
Ctype_wrapper< float > | |
Ctype_wrapper< std::complex< double > > | |
Ctype_wrapper< std::complex< float > > | |
Cstream_id | Helper class to wrap stream id (integer number) |
►Nfft | FFT-related functions and objects |
CGrid | Helper class to create FFT grids of given sizes and compute indices in space- and frequency domains |
CGvec | A set of G-vectors for FFTs and G+k basis functions |
CGvec_fft | Stores information about G-vector partitioning between MPI ranks for the FFT transformation |
CGvec_shells | Helper class to manage G-vector shells and redistribute G-vectors for symmetrization |
CSpFFT_Grid | Type traits to handle Spfft grid for different precision type |
CSpFFT_Grid< double > | |
CSpFFT_Grid< std::complex< double > > | |
CSpFFT_Transform | Type traits to handle Spfft driver for different precision type |
CSpFFT_Transform< double > | |
CSpFFT_Transform< std::complex< double > > | |
Cz_column_descriptor | Descriptor of the z-column (x,y fixed, z varying) of the G-vectors |
►Nla | Interface to linear algebra BLAS/LAPACK functions |
CBLACS_grid | BLACS grid wrapper |
Cconstant | |
Cdmatrix | Distributed matrix |
CEigensolver | Interface to different eigen-solvers |
CEigensolver_cuda | |
CEigensolver_dlaf | |
CEigensolver_elpa | |
CEigensolver_lapack | |
CEigensolver_magma | |
CEigensolver_magma_gpu | |
CEigensolver_scalapack | |
Clinalg_base | Base class for linear algebra interface |
Cwrap | |
►Nlocal | Internal implementation of beta-projectors generator |
COperatorBase | |
COverlap_operator | |
►Nlr | Linear respone functions and objects |
CIdentity_preconditioner | |
CLinear_response_operator | |
CSmoothed_diagonal_preconditioner | |
CWave_functions_wrap | |
►Nmixer | Mixer functions and objects |
►Nmixer_impl | |
CAxpy | |
CAxpy< 0, FUNCS... > | |
CCopy | |
CCopy< 0, FUNCS... > | |
CInnerProduct | Compute inner product <x|y> between pairs of functions in tuples and accumulate in the result |
CInnerProduct< 0, normalize, FUNCS... > | |
CRotate | |
CRotate< 0, FUNCS... > | |
CScaling | |
CScaling< 0, FUNCS... > | |
CAnderson | Anderson mixer |
CAnderson_stable | Anderson mixer |
CBroyden2 | Broyden mixer |
CFunctionProperties | Describes operations on a function type used for mixing |
CLinear | |
CMixer | Abstract mixer for variadic number of Function objects, which are described by FunctionProperties |
►Nmpi | MPI related functions and classes |
Cblock_data_descriptor | |
CCommunicator | MPI communicator wrapper |
CGrid | MPI grid interface |
Cmpi_comm_deleter | |
Cop_wrapper | |
Cop_wrapper< op_t::land > | |
Cop_wrapper< op_t::max > | |
Cop_wrapper< op_t::min > | |
Cop_wrapper< op_t::sum > | |
Cpstdout | Parallel standard output |
CRequest | |
Ctype_wrapper | |
Ctype_wrapper< bool > | |
Ctype_wrapper< char > | |
Ctype_wrapper< double > | |
Ctype_wrapper< float > | |
Ctype_wrapper< int > | |
Ctype_wrapper< int16_t > | |
Ctype_wrapper< long double > | |
Ctype_wrapper< std::complex< double > > | |
Ctype_wrapper< std::complex< float > > | |
Ctype_wrapper< uint32_t > | |
Ctype_wrapper< unsigned char > | |
Ctype_wrapper< unsigned long > | |
Ctype_wrapper< unsigned long long > | |
►Nr3 | Work with 3D vectors and matrices |
Cmatrix | Handling of a 3x3 matrix of numerical data types |
Cvector | Simple implementation of 3d vector |
►Nrte | Run-time error and warning handling |
Costream | |
►Nsddk | |
Cis_complex | Check is the type is a complex number; by default it is not |
Cis_complex< std::complex< T > > | Check is the type is a complex number: for std::complex<T> it is true |
Cmdarray | Multidimensional array with the column-major (Fortran) order |
Cmdarray_index_descriptor | Index descriptor of mdarray |
Cmemory_pool | |
►Cmemory_pool_deleter | Deleter for the allocated memory pointer from a given memory pool |
Cmemory_pool_deleter_impl | |
►Cmemory_t_deleter | Deleter for the allocated memory pointer of a given type |
Cmemory_t_deleter_impl | |
►Cmemory_t_deleter_base | Base class for smart pointer deleters |
Cmemory_t_deleter_base_impl | |
►Nsf | Special functions |
CSpherical_Bessel_functions | Spherical Bessel functions \( j_{\ell}(q x) \) up to lmax |
►Nsmearing | Occupancy smearing functions |
Ccold | |
Cfermi_dirac | |
Cgaussian | |
Cmethfessel_paxton | |
►Nwf | Namespace for the wave-functions |
Cband_range | Describe a range of bands |
Cdevice_memory_guard | Helper class to allocate and copy wave-functions to/from device |
Cshuffle_to | |
Cspin_range | Describe a range of spins |
CWave_functions | Wave-functions representation |
CWave_functions_base | Base class for the wave-functions |
CWave_functions_fft | Wave-fucntions in the FFT-friendly distribution |
CWave_functions_mt | Wave-functions for the muffin-tin part of LAPW |
Cangular_momentum | Angular momentum quantum number |
Cany_ptr | Handle deallocation of a poiniter to an object of any type |
CArray1d | TODO: Array1d owns data.. |
CAtom | Data and methods specific to the actual atom in the unit cell |
Catom_index_t | |
CAtom_symmetry_class | Data and methods specific to the symmetry class of the atom |
Catom_symmetry_class_index_t | |
CAtom_type | Defines the properties of atom type |
CAtom_type_base | Base class for sirius::Atom_type and sirius::Free_atom classes |
Catom_type_index_t | |
CAugmentation_operator | Augmentation charge operator Q(r) of the ultrasoft pseudopotential formalism |
Cbasic_index_t | Basic index type |
Cbasis_function_index_descriptor | |
Cbasis_functions_index | A helper class to establish various index mappings for the atomic basis functions |
Cbeta_chunk_t | Describe chunk of beta-projectors for a block of atoms |
Cbeta_desc_idx | Named index of a descriptor of beta-projectors. The same order is used by the GPU kernel |
CBeta_projector_generator | |
CBeta_projectors | Stores <G+k | beta> expansion |
CBeta_projectors_base | Base class for beta-projectors, gradient of beta-projectors and strain derivatives of beta-projectors |
Cbeta_projectors_coeffs_t | Stores a chunk of the beta-projector and metadata |
CBeta_projectors_gradient | Compute gradient of beta-projectors over atomic positions \( d \langle {\bf G+k} | \beta \rangle / d \tau_{\alpha} \) |
CBeta_projectors_strain_deriv | |
CBound_state | |
Ccallback_functions_t | Store all callback functions in one place |
Ccmd_args | Simple command line arguments handler |
CConfig | |
►Cconfig_t | |
Ccontrol_t | Control parameters |
►Chubbard_t | Hubbard U correction |
Clocal_list_t | |
Clocal_t | Description of the on-site (local) Hubbard interaction |
Cnonlocal_list_t | |
Cnonlocal_t | Description of the off-site (nonlocal) Hubbard interaction |
Citerative_solver_t | Parameters of the iterative solver |
Cmixer_t | Parameters of the mixer |
Cnlcg_t | Non-linear conjugate gradient minimisation |
Cparameters_t | Parameters of the simulation |
Csettings_t | Settings control the internal parameters related to the numerical implementation |
Cunit_cell_t | Unit cell representation |
Cvcsqnm_t | Variable cell shape stabilized quasi Newton method (VC-SQNM) |
CCrystal_symmetry | Representation of the crystal symmetry |
CCUDA_timer | |
CCUDA_timers_wrapper | |
CD_operator | |
Cdavidson_result_t | Result of Davidson solver |
CDensity | Generate charge density and magnetization from occupied spinor wave-functions |
Cdensity_matrix_t | |
CDFT_ground_state | The whole DFT ground state implementation |
Cdiagonalize_result_t | |
CDiagonalPreconditioner | |
CEnergy | Kohn-Sham energy |
CEnu_finder | |
Cffmt | Floating-point formatting (precision and width) |
CField4D | Four-component function consisting of scalar and vector parts |
CForce | Compute atomic forces |
CFree_atom | Full potential free atom solver |
CGaunt_coefficients | Compact storage of non-zero Gaunt coefficients \( \langle \ell_1 m_1 | \ell_3 m_3 | \ell_2 m_2 \rangle \) |
Cgaunt_L1_L2 | Used in the {lm1, lm2, coefficient} : {lm3} way of grouping non-zero Gaunt coefficients |
Cgaunt_L3 | Used in the {lm1, lm2} : {lm3, coefficient} way of grouping non-zero Gaunt coefficients |
CGPU_Complex | Helper type traits to template kernel function |
CGPU_Complex< double > | |
CGPU_Complex< float > | |
CHamiltonian0 | Represent the k-point independent part of Hamiltonian |
CHamiltonian_k | Representation of Kohn-Sham Hamiltonian |
Chbar | Horisontal bar |
►CHDF5_tree | Interface to the HDF5 library |
CHDF5_attribute | |
CHDF5_dataset | Auxiliary class to handle HDF5 Dataset object |
CHDF5_dataspace | Auxiliary class to handle HDF5 Dataspace object |
CHDF5_group | Auxiliary class to handle HDF5 Group object |
Chdf5_type_wrapper | |
Chdf5_type_wrapper< double > | |
Chdf5_type_wrapper< float > | |
Chdf5_type_wrapper< int > | |
Chdf5_type_wrapper< uint8_t > | |
CHubbard | Apply Hubbard correction in the collinear case |
CHubbard_matrix | Describes Hubbard orbital occupancy or potential correction matrices |
Chubbard_orbital_descriptor | Structure containing all information about a specific hubbard orbital (including the radial function) |
Cidentity | |
CInverseS_k | |
CK_point | K-point related variables and methods |
CK_point_set | Set of k-points |
Ckp_index_t | K-point index type |
CLattice_relaxation | |
Clo_basis_descriptor | Descriptor of the local-orbital part of the LAPW+lo basis |
►CLocal_operator | Representation of the local operator |
Cv_local_index_t | |
Clocal_orbital_descriptor | Descriptor of a local orbital radial function |
Cmagnetic_group_symmetry_descriptor | Descriptor of the magnetic group symmetry operation |
CMatching_coefficients | |
CMatrix | |
CMeasurement | |
Cnearest_neighbour_descriptor | Descriptor of an atom in a list of nearest neighbours for each atom |
CNon_local_operator | Non-local part of the Hamiltonian and S-operator in the pseudopotential method |
Cnull_stream_t | |
COccupation_matrix | |
Cpaw_atom_index_t | |
CPAW_density | PAW density storage |
CPAW_field4D | PAW density and potential storage |
CPeriodic_function | Representation of the periodical function on the muffin-tin geometry |
Cperiodic_function_ptr_t | Describe external pointers to periodic function |
CPotential | Generate effective potential from charge density and magnetization |
Cps_atomic_wf_descriptor | Store basic information about radial pseudo wave-functions |
CQ_operator | |
Cradial_function_index_descriptor | Descriptor for the atomic radial functions |
Cradial_functions_index | Radial basis function index |
CRadial_grid | Base class for radial grids |
CRadial_grid_exp | |
CRadial_grid_ext | External radial grid provided as a list of points |
CRadial_grid_lin | |
CRadial_grid_lin_exp | |
CRadial_grid_pow | |
CRadial_integrals_atomic_wf | Radial integrals of the atomic centered orbitals |
CRadial_integrals_aug | Radial integrals of the augmentation operator |
CRadial_integrals_base | Base class for all kinds of radial integrals |
CRadial_integrals_beta | Radial integrals of beta projectors |
CRadial_integrals_rho_core_pseudo | |
CRadial_integrals_rho_free_atom | |
CRadial_integrals_rho_pseudo | |
Cradial_integrals_t | Store all radial integrals in one place |
CRadial_integrals_vloc | |
Cradial_solution_descriptor | Describes radial solution |
CRadial_solver | Finds a solution to radial Schrodinger, Koelling-Harmon or Dirac equation |
CReal | |
CReal< gpu_complex_type< double > > | |
CReal< gpu_complex_type< float > > | |
CReal< std::complex< T > > | |
CS_k | |
CScalar | |
Cserializer | Serialize and deserialize objects |
CSHT | Spherical harmonics transformations and related oprtations |
CSimulation_context | Simulation context is a set of parameters and objects describing a single simulation |
CSimulation_parameters | Set of basic parameters of a simulation |
Csirius_context_handler | Opaque wrapper for simulation context handler |
Csirius_free_handler | Free any of the SIRIUS handlers (context, ground state or k-points) |
Csirius_ground_state_handler | Opaque wrapper for DFT ground statee handler |
Csirius_kpoint_set_handler | Opaque wrapper for K-point set handler |
CSmooth_periodic_function | Representation of a smooth (Fourier-transformable) periodic function |
Csmooth_periodic_function_ptr_t | |
CSmooth_periodic_vector_function | Vector of the smooth periodic functions |
Cspace_group_symmetry_descriptor | Descriptor of the space group symmetry operation |
CSpheric_function | Function in spherical harmonics or spherical coordinates representation |
CSpheric_function_set | |
Cspheric_function_set_ptr_t | |
CSpheric_vector_function | 3D vector function |
►Csplindex | Base class for split index |
Clocation_t | Pair of <local index, block_id> describing the location of a global index element |
Csplindex_block | |
Csplindex_block_cyclic | |
Csplindex_chunk | Externally defined block distribution |
Csplindex_iterator_t | |
CSpline | Cubic spline with a not-a-knot boundary conditions |
Cstep_function_t | Representation of the unit step function |
CStress | Stress tensor |
Cstrong_type | |
CTeter | |
CU_operator | |
CUltrasoft_preconditioner | |
CUnit_cell | Representation of a unit cell |
Cunit_cell_parameters_descriptor | |
CXC_functional | Interface class to Libxc |
CXC_functional_base | Interface class to Libxc |
►Nstd | |
Chash< nlohmann::NLOHMANN_BASIC_JSON_TPL > | Hash value for JSON objects |
Cless< ::nlohmann::detail::value_t > | |
Ctuple_element< N, ::nlohmann::detail::iteration_proxy_value< IteratorType > > | |
Ctuple_size<::nlohmann::detail::iteration_proxy_value< IteratorType > > | |
►Nvcsqnm | Variable cell stable quasi-Newton lattice optimizer |
►Nhlist_space | |
CHistoryList | |
►NPES_optimizer | |
Cperiodic_optimizer | |
►Nsqnm_space | |
CSQNM | |
Cadl_serializer | Namespace for Niels Lohmann |
Catomic_level_descriptor | Describes single atomic level |
Cbasic_json | Namespace for Niels Lohmann |
Cbyte_container_with_subtype | Internal type for a backed binary type |
►Cjson_pointer | JSON Pointer defines a string syntax for identifying a specific value within a JSON document |
Cstring_t_helper | |
Cstring_t_helper< NLOHMANN_BASIC_JSON_TPL > | |
Cjson_sax | SAX interface |
Cnormalized_preconditioned_residuals_result | |
Cordered_map | Minimal map-like container that preserves insertion order |
Cresidual_result_t | |
Csirius_context_handler_t | |
Csirius_ground_state_handler_t | |
Csirius_kpoint_set_handler_t | |