Google

Main Page   Class Hierarchy   Compound List   File List   Compound Members   Related Pages  

MPQC Compound List

Here are the classes, structs, unions and interfaces with brief descriptions:
sc::AccResult< T >This associates a result datum with an accuracy
sc::AccResultInfoThis is like ResultInfo but the accuracy with which a result was computed as well as the desired accuracy are stored
sc::ActiveMsgMemoryGrpThe ActiveMsgMemoryGrp abstract class specializes the MsgMemoryGrp class
sc::AngularIntegratorAn abstract base class for angular integrators
sc::AtomInfoThe AtomInfo class provides information about atoms
sc::BcastStateThis creates and forwards/retrieves data from either a BcastStateRecv or a BcastStateSend depending on the value of the argument to constructor
sc::BcastStateInBinBcastStateBin reads a file in written by StateInBin on node 0 and broadcasts it to all nodes so state can be simultaneously restored on all nodes
sc::BcastStateRecvBcastStateRecv does the receive part of a broadcast of an object to all nodes
sc::BcastStateSendBcastStateSend does the send part of a broadcast of an object to all nodes
sc::Becke88XFunctionalImplements Becke's 1988 exchange functional
sc::BeckeIntegrationWeightImplements Becke's integration weight scheme
sc::BendSimpleCoThe BendSimpleCo class describes an bend internal coordinate of a molecule
sc::BFGSUpdateThe DFPUpdate class is used to specify a Broyden, Fletcher, Goldfarb, and Shanno hessian update scheme
sc::CartesianIterCartesianIter gives the ordering of the Cartesian functions within a shell for the particular integrals specialization
sc::CartMolecularCoorThe CartMolecularCoor class implements Cartesian coordinates in a way suitable for use in geometry optimizations
sc::CharacterTableThe CharacterTable class provides a workable character table for all of the non-cubic point groups
sc::ClassDescThis class is used to contain information about classes
sc::ClassKeyProvides a key into a map of classes
sc::CLHFCLHF is a Hartree-Fock specialization of CLSCF
sc::CLSCFThe CLSCF class is a base for classes implementing a self-consistent procedure for closed-shell molecules
sc::ComputeThe Compute class provides a means of keeping results up to date
sc::ConnollyShapeDiscreteConnollyShape and ConnollyShape should produce the same result
sc::ConvergenceThe Convergence class is used by the optimizer to determine when an optimization is converged
sc::CorrelationTableThe CorrelationTable class provides a correlation table between two point groups
sc::DebuggerThe Debugger class describes what should be done when a catastrophic error causes unexpected program termination
sc::DenFunctionalAn abstract base class for density functionals
sc::DenIntegratorAn abstract base class for integrating the electron density
sc::DerivCentersDerivCenters keeps track the centers that derivatives are taken with respect to
sc::DescribedClassClasses which need runtime information about themselves and their relationship to other classes can virtually inherit from DescribedClass
sc::DFPUpdateThe DFPUpdate class is used to specify a Davidson, Fletcher, and Powell hessian update scheme
sc::DiagSCMatrixThe SymmSCMatrix class is the abstract base class for diagonal double valued matrices
sc::DIISThe DIIS class provides DIIS extrapolation
sc::DiscreteConnollyShapeDiscreteConnollyShape and ConnollyShape should produce the same result
sc::DistSCMatrixKitThe DistSCMatrixKit produces matrices that work in a many processor environment
sc::DistShellPairDistributes shell pairs either statically or dynamically
sc::EFCOptThe EFCOpt class implements eigenvector following as described by Baker in J
sc::EulerMaclaurinRadialIntegratorAn implementation of a radial integrator using the Euler-Maclaurin weights and grid points
sc::ExEnvThe ExEnv class is used to find out about how the program is being run
sc::FinDispMolecularHessianComputes the molecular hessian by finite displacements of gradients
sc::ForceLink< T, A >This, together with ForceLinkBase, is used to force code for particular classes to be linked into executables
sc::ForceLinkBase< A >This, together with ForceLink, is used to force code for particular classes to be linked into executables
sc::FunctionThe Function class is an abstract base class that, given a set of coordinates, will compute a value and possibly a gradient and hessian at that point
sc::G96XFunctionalImplements the Gill 1996 (G96) exchange functional
sc::GaussianBasisSetThe GaussianBasisSet class is used describe a basis set composed of atomic gaussian orbitals
sc::GaussianBasisSet::ValueDataThis holds scratch data needed to compute basis function values
sc::GaussianShellA Gaussian orbital shell
sc::GaussLegendreAngularIntegratorAn implementation of an angular integrator using the Gauss-Legendre weights and grid points
sc::HessianUpdateThe HessianUpdate abstract class is used to specify a hessian update scheme
sc::HSOSHFHSOSHF is a Hartree-Fock specialization of HSOSSCF
sc::HSOSSCFThe HSOSSCF class is a base for classes implementing a self-consistent procedure for high-spin open-shell molecules
sc::IdentifierIdentifier's are used to distinguish and order objects
sc::IdentityIdentity gives objects a unique identity and ordering relationship relative to all other objects
sc::IdentityTransformThe IdentityTransform is a special case of NonlinearTransform were no transformation takes place
sc::Int1eV3Int2eV3 is a class wrapper for the one body part of the C language IntV3 library
sc::Int2eV3Int2eV3 is a class wrapper for the two body part of the C language IntV3 library
sc::IntCoorThe IntCoor abstract class describes an internal coordinate of a molecule
sc::IntCoorGenIntCoorGen generates a set of simple internal coordinates for a molecule
sc::IntegralThe Integral abstract class acts as a factory to provide objects that compute one and two electron integrals
sc::IntegralV3IntegralV3 computes integrals between Gaussian basis functions
sc::IntegrationWeightAn abstract base class for computing grid weights
sc::intMessageGrpUses integer message types to send and receive messages
sc::IntMolecularCoorThe IntMolecularCoor abstract class describes a molecule's coordinates in terms of internal coordinates
sc::IrreducibleRepresentationThe IrreducibleRepresentation class provides information associated with a particular irreducible representation of a point group
sc::ISphericalTransformThis describes a solid harmonic to Cartesian transform
sc::KeyValThe KeyVal class is designed to simplify the process of allowing a user to specify keyword/value associations to a C++ program
sc::LebedevLaikovIntegratorAn implementation of a Lebedev angular integrator
sc::LineOptThe LineOpt abstract class is used to perform one dimensional optimizations
sc::LinIPSimpleCoThe LinIPSimpleCo class describes an in-plane component of a linear bend internal coordinate of a molecule
sc::LinOPSimpleCoThe LinOPSimpleCo class describes an out-of-plane component of a linear bend internal coordinate of a molecule
sc::LocalSCMatrixKitThe LocalSCMatrixKit produces matrices that work in a single processor environment
sc::LSDACFunctionalAn abstract base class for local correlation functionals
sc::LYPCFunctionalImplements the Lee, Yang, and Parr functional
sc::MBPT2The MBPT2 class implements several second-order perturbation theory methods
sc::MemoryGrpThe MessageGrp abstract class provides a way of accessing distributed memory in a parallel machine
sc::MemoryGrpBuf< data_t >The MemoryGrpBug class provides access to pieces of the global shared memory that have been obtained with MemoryGrp
sc::MessageGrpThe MessageGrp abstract class provides a mechanism for moving data and objects between nodes in a parallel machine
sc::MolecularCoorThe MolecularCoor abstract class describes the coordinate system used to describe a molecule
sc::MolecularEnergyThe MolecularEnergy abstract class inherits from the Function class
sc::MolecularFormulaThe MolecularFormula class is used to calculate the molecular formula of a Molecule
sc::MolecularFrequenciesThe MolecularFrequencies class is used to compute the molecular frequencies and thermodynamic information
sc::MoleculeThe Molecule class contains information about molecules
sc::MPIMessageGrpThe MPIMessageGrp class is an concrete implementation of MessageGrp that uses the MPI 1 library
sc::mPW91XFunctionalImplements a modified 1991 Perdew-Wang exchange functional
sc::MsgMemoryGrpA MsgMemoryGrp that initializes its data using a messagegrp
sc::MsgStateBufRecvThe MsgStateBufRecv is an abstract base class that buffers objects sent through a MessageGrp
sc::MsgStateRecvThe MsgStateRecv is an abstract base class that receives objects from nodes in a MessageGrp
sc::MsgStateSendThe MsgStateSend is an abstract base class that sends objects to nodes in a MessageGrp
sc::MTMPIMemoryGrpThis MemoryGrp class requires a MT-safe MPI implementation
sc::NCAccResult< T >This associates a result non-class datum with an accuracy
sc::NCResult< T >This is similar to Result, but can be used with non-class types
sc::NElFunctionalThe NElFunctional computes the number of electrons
sc::NonlinearTransformThe NonlinearTransform class transforms between two nonlinear coordinate systems
sc::OneBodyDerivIntOneBodyInt is an abstract base class for objects that compute one body derivative integrals
sc::OneBodyDerivIntV3This implements one body derivative integrals in the IntV3 library
sc::OneBodyIntOneBodyInt is an abstract base class for objects that compute integrals between two basis functions
sc::OneBodyIntV3This implements most one body integrals in the IntV3 library
sc::OneBodyWavefunctionA OneBodyWavefunction is a MolecularEnergy that solves an effective one-body problem
sc::OptimizeThe Optimize class is an abstract base class for classes that find the extreme points of Function's
sc::P86CFunctionalImplements the Perdew 1986 (P86) correlation functional
sc::ParentClassGives one parent class of a class
sc::ParentClassesGives a list of parent classes of a class
sc::ParsedKeyValConverts textual information into keyword/value assocations
sc::PBECFunctionalImplements the Perdew-Burke-Ernzerhof (PBE) correlation functional
sc::PBEXFunctionalImplements the Perdew-Burke-Ernzerhof (PBE) exchange functional
sc::PointGroupThe PointGroup class is really a place holder for a CharacterTable
sc::PointInputDataContains data needed at each point by a DenFunctional
sc::PointOutputDataContains data generated at each point by a DenFunctional
sc::PowellUpdateThe PowellUpdate class is used to specify a Powell hessian update
sc::ProcMemoryGrpThe ProcMessageGrp concrete class provides an implementation of MemoryGrp for a single processor
sc::ProcMessageGrpProcMessageGrp provides a concrete specialization of MessageGrp that supports only one node
sc::ProcThreadGrpThe ProcThreadGrp class privides a concrete thread group appropriate for an environment where there is only one thread
sc::PsiCCSDPsiCCSD is a concrete implementation of Psi CCSD wave function
sc::PsiCCSD_TPsiCCSD_T is a concrete implementation of Psi CCSD(T) wave function
sc::PsiCLHFPsiCLHF is a concrete implementation of Psi RHF wave function
sc::PsiExEnvPsiExEnv specifies a Psi calculation
sc::PsiFile11PsiFile11 is a Psi gradient file
sc::PsiHSOSHFPsiHSOSHF is a concrete implementation of Psi ROHF wave function
sc::PsiInputPsiInput is a Psi input file
sc::PsiSCFPsiSCF is an abstract base for all Psi SCF wave functions
sc::PsiUHFPsiUHF is a concrete implementation of Psi UHF wave function
sc::PsiWavefunctionPsiWavefunction is an abstract base for all Psi wave functions
sc::PthreadThreadGrpThe PthreadThreadGrp class privides a concrete thread group appropriate for an environment where pthreads is available
sc::PumaThreadGrpThe PumaThreadGrp class privides a concrete thread group appropriate for the intel teraflops machine
sc::PW86XFunctionalImplements the Perdew-Wang 1986 (PW86) Exchange functional
sc::PW91CFunctionalThe Perdew-Wang 1991 correlation functional computes energies and densities using the designated local correlation functional
sc::PW91XFunctionalThe Perdew-Wang 1991 exchange functional computes energies and densities using the designated local correlation functional
sc::PW92LCFunctionalImplements the PW92 local (LSDA) correlation term
sc::PZ81LCFunctionalImplements the PZ81 local (LSDA) correlation functional
sc::QNewtonOptThe QNewtonOpt implements a quasi-Newton optimization scheme
sc::RadialAngularIntegratorAn implementation of an integrator using any combination of a RadianIntegrator and an AngularIntegrator
sc::RadialIntegratorAn abstract base class for radial integrators
sc::RedundantCartesianIterRedundantCartesianIter objects loop through all possible combinations of a given number of axes
sc::RedundantCartesianSubIterLike RedundantCartesianIter, except a, b, and c are fixed to a given value
sc::RedundMolecularCoorThe RedundMolecularCoor class provides a redundant set of simple internal coordinates
sc::Ref< T >A template class that maintains references counts
sc::RefBaseProvides a few utility routines common to all Ref template instantiations
sc::RefCountThe base class for all reference counted objects
sc::RefDiagSCMatrixThe RefDiagSCMatrix class is a smart pointer to an DiagSCMatrix specialization
sc::RefSCDimensionThe RefSCDimension class is a smart pointer to an SCDimension specialization
sc::RefSCMatrixThe RefSCMatrix class is a smart pointer to an SCMatrix specialization
sc::RefSCVectorThe RefSCVector class is a smart pointer to an SCVector specialization
sc::RefSymmSCMatrixThe RefSymmSCMatrix class is a smart pointer to an SCSymmSCMatrix specialization
sc::ReplSCMatrixKitThe ReplSCMatrixKit produces matrices that work in a many processor environment
sc::Result< T >Result are members of Compute specializations that keep track of whether or not a particular result should be computed or if it has already been computed
sc::ResultInfoThis is a base class for all of Compute's result types
sc::SavableStateBase class for objects that can save/restore state
sc::SavableStateProxyCreate a proxy for a SavableState object
sc::ScaledTorsSimpleCoThe ScaledTorsSimpleCo class describes an scaled torsion internal coordinate of a molecule
sc::SCBlockInfoSCBlockInfo contains blocking information for the SCDimension class
sc::SCDimensionThe SCDimension class is used to determine the size and blocking of matrices
sc::SCElementOpObjects of class SCElementOp are used to perform operations on the elements of matrices
sc::SCElementOp2The SCElementOp2 class is very similar to the SCElementOp class except that pairs of blocks are treated simultaneously
sc::SCElementOp3The SCElementOp3 class is very similar to the SCElementOp class except that a triplet of blocks is treated simultaneously
sc::SCExtrapDataSCExtrapData hold the data to be extrapolated needed by SelfConsistentExtrapolation
sc::SCExtrapErrorSCExtrapError holds the error data needed by SelfConsistentExtrapolation
sc::SCFThe SCF class is the base for all classes that use a self-consistent field procedure to solve an effective one body problem
sc::SCFormIOThis utility class is used to print only on node 0 and to provide attractive indentation of output
sc::SCMatrixThe SCMatrix class is the abstract base class for general double valued n by m matrices
sc::SCMatrixBlockSCMatrixBlock is the base clase for all types of blocks that comprise matrices and vectors
sc::SCMatrixBlockIterThe SCMatrixBlockIter class is used to described iterates that loop through the elements in a block
sc::SCMatrixDiagBlockThe SCMatrixDiagBlock describes a diagonal piece of a matrix
sc::SCMatrixDiagSubBlockThe SCMatrixDiagSubBlock describes a diagonal subblock of a matrix
sc::SCMatrixKitThe SCMatrixKit abstract class acts as a factory for producing matrices
sc::SCMatrixLTriBlockThe SCMatrixLTriBlock describes a triangular piece of a matrix
sc::SCMatrixLTriSubBlockThe SCMatrixLTriSubBlock describes a triangular subblock of a matrix
sc::SCMatrixRectBlockThe SCMatrixRectBlock describes a rectangular piece of a matrix
sc::SCMatrixRectSubBlockThe SCMatrixRectSubBlock describes a rectangular piece of a matrix
sc::SCMatrixSubblockIterObjects of class SCMatrixSubblockIter are used to iterate through the blocks of a matrix
sc::scprintfThis class allows printf like output to put sent to an ostream
sc::SCVectorThe SCVector class is the abstract base class for double valued vectors
sc::SCVectorSimpleBlockThe SCVectorSimpleBlock describes a piece of a vector
sc::SCVectorSimpleSubBlockThe SCVectorSimpleSubBlock describes a subblock of a vector
sc::SelfConsistentExtrapolationThe SelfConsistentExtrapolation abstract class is used to iteratively solve equations requiring a self consistent solution, such as,
sc::SetIntCoorThe SetIntCoor class describes a set of internal coordinates
sc::ShapeA Shape is a Volume represents an 3D solid
sc::ShellRotationCompute the transformation matrices that maps a set of Cartesian functions into to another set of Cartesian functions in a rotated coordinate system
sc::ShmMemoryGrpThe ShmMemoryGrp concrete class provides an implementation of MsgMemoryGrp
sc::ShmMessageGrpThe ShmMessageGrp class is an implementation of MessageGrp that allows multiple process to be started that communicate with shared memory
sc::SimpleCoThe SimpleCo abstract class describes a simple internal coordinate of a molecule
sc::SlaterXFunctionalImplements the Slater exchange functional
sc::SOBasisA SOBasis object describes the transformation from an atomic orbital basis to a symmetry orbital basis
sc::SOTransformSOTransform maintains a list of AO shells that are be used to compute the SO
sc::SOTransformFunctionSOTransformShell describes how an AO function contributes to an SO function in a particular SO shell
sc::SOTransformShellSOTransformShell maintains a list of AO functions contribute to an SO function in a particular SO shell
sc::SphericalTransformThis is a base class for a container for a sparse Cartesian to solid harmonic basis function transformation
sc::SphericalTransformComponentThis is a base class for a container for a component of a sparse Cartesian to solid harmonic basis function transformation
sc::SphericalTransformIterThis iterates through the components of a SphericalTransform
sc::SSAccResult< T >This associates a result datum with an accuracy
sc::StateInRestores objects that derive from SavableState
sc::StateInBinRead objects written with StateOutBin
sc::StateInFileReads state information from a file
sc::StateInTextReads state information written with StateOutText
sc::StateOutSerializes objects that derive from SavableState
sc::StateOutBinSave state to a binary file
sc::StateOutFileWrites state information to files
sc::StateOutTextWrites out state information in an almost human readable format
sc::StateRecvStateRecv is a concrete specialization of MsgStateRecv that does the receive part of point to point communication in a MessageGrp
sc::StateSendStateSend is a concrete specialization of MsgStateSend that does the send part of point to point communication in a MessageGrp
sc::StdDenFunctionalThe StdDenFunctional class is used to construct the standard density functionals
sc::StreSimpleCoThe StreSimpleCo class describes an stretch internal coordinate of a molecule
sc::SumDenFunctionalThe SumDenFunctional computes energies and densities using the a sum of energy density functions method
sc::SumIntCoorSumIntCoor is used to construct linear combinations of internal coordinates
sc::SymmetryOperationThe SymmetryOperation class provides a 3 by 3 matrix representation of a symmetry operation, such as a rotation or reflection
sc::SymmMolecularCoorThe SymmMolecularCoor class derives from IntMolecularCoor
sc::SymmSCMatrixThe SymmSCMatrix class is the abstract base class for symmetric double valued matrices
sc::SymRepThe SymRep class provides an n dimensional matrix representation of a symmetry operation, such as a rotation or reflection
sc::ThreadThe Thread abstract class defines an interface which must be implemented by classes wishing to be run as threads
sc::ThreadGrpThe ThreadGrp abstract class provides a means to manage separate threads of control
sc::ThreadLockThe ThreadLock abstract class provides mutex locks to be used in conjunction with ThreadGrp's
sc::TorsSimpleCoThe TorsSimpleCo class describes an torsion internal coordinate of a molecule
sc::TranslateDataGeneric data translation
sc::TranslateDataByteSwapData translation to an external representation with bytes swapped
sc::TranslateDataInConvert data from other formats
sc::TranslateDataOutConvert data to other formats
sc::TwoBodyDerivIntThis is an abstract base type for classes that compute integrals involving two electrons
sc::TwoBodyDerivIntV3This implements electron repulsion derivative integrals in the IntV3 library
sc::TwoBodyIntThis is an abstract base type for classes that compute integrals involving two electrons
sc::TwoBodyIntV3This implements electron repulsion integrals in the IntV3 library
sc::UnionShapeA UnionShape is volume enclosed by a set of Shape's
sc::UnitsThe Units class is used to perform unit converions
sc::UnrestrictedSCFA base class for unrestricted self-consistent-field methods
sc::VDWShapeThe VDWShape class describes the surface of a molecule as the union of atom centered spheres, each the van der Waals radius of the atom
sc::VolumeA Volume is a Function of three variables
sc::VWN1LCFunctionalThe VWN1LCFunctional computes energies and densities using the VWN1 local correlation term (from Vosko, Wilk, and Nusair)
sc::VWN2LCFunctionalThe VWN2LCFunctional computes energies and densities using the VWN2 local correlation term (from Vosko, Wilk, and Nusair)
sc::VWN3LCFunctionalThe VWN3LCFunctional computes energies and densities using the VWN3 local correlation term (from Vosko, Wilk, and Nusair)
sc::VWN4LCFunctionalThe VWN4LCFunctional computes energies and densities using the VWN4 local correlation term (from Vosko, Wilk, and Nusair)
sc::VWN5LCFunctionalThe VWN5LCFunctional computes energies and densities using the VWN5 local correlation term (from Vosko, Wilk, and Nusair)
sc::VWNLCFunctionalAn abstract base class from which the various VWN (Vosko, Wilk and Nusair) local correlation functional (1, 2, 3, 4, 5) classes are derived
sc::WavefunctionA Wavefunction is a MolecularEnergy that utilizies a GaussianBasisSet
sc::XalphaFunctionalImplements the Xalpha exchange functional

Generated at Fri Jan 10 08:14:10 2003 for MPQC 2.1.3 using the documentation package Doxygen 1.2.14.