Classes | |
| class | PCDPreconditionerFactory | 
| class | AmesosSolver | 
| class | AnasaziEigensolver | 
| class | InitTraits | 
| class | InitTraits< SimpleMV, LinearOperator< double > > | 
| class | AztecSolver | 
| class | BasicLMBFGS | 
| class | BasicLMBFGSDirection | 
| class | BelosSolver | 
| class | BICGSTABSolver | 
| class | BlockIterator | 
| class | BlockOperatorBase | 
| class | SetableBlockOperatorBase | 
| class | BlockTriangularSolver | 
| class | BlockVectorBase | 
| class | BlockVectorSpaceBase | 
| class | CollectivelyConfigurableMatrixFactory | 
| class | CompoundTester | 
| class | ConvergenceMonitor | 
| class | ConstDataChunk | 
| class | NonConstDataChunk | 
| class | Debug | 
| class | DefaultBlockVector | 
| class | DefaultBlockVectorSpace | 
| class | DefaultOptConvergenceTest | 
| class | DenseLUSolver | 
| class | DenseSerialMatrix | 
| class | DenseSerialMatrixFactory | 
| class | Eigensolver | 
| class | EigensolverBase | 
| class | EpetraGhostImporter | 
| class | EpetraGhostView | 
| class | EpetraMatrix | 
| class | EpetraMatrixFactory | 
| class | EpetraVector | 
| class | EpetraVectorSpace | 
| class | EpetraVectorType | 
| class | ErrorPolling | 
| ErrorPolling provides utilities for establishing agreement between processors on whether an std::exception has been detected on any one processor.  More... | |
| class | InternalError | 
| class | RuntimeError | 
| class | GeneralizedIndex | 
| class | GenericLeftPreconditioner | 
| class | GenericRightPreconditioner | 
| class | GhostImporter | 
| class | GhostView | 
| class | ConstHandleTraits | 
| class | ConstHandleTraits< const X > | 
| class | Handle | 
| class | Handleable | 
| class | HeatOperator1D | 
| class | IfpackOperator | 
| class | ILUFactorizableOp | 
| class | ILUKPreconditionerFactory | 
| class | IncrementallyConfigurableMatrixFactory | 
| class | InverseOperator | 
| class | IterativeSolver | 
| class | KrylovSolver | 
| class | LCNBase | 
| class | LCN | 
| class | LCN< Scalar, 1 > | 
| class | LCN< Scalar, 2 > | 
| class | LCN< Scalar, 3 > | 
| class | LinearCombinationTester | 
| class | LinearOperatorBase | 
| class | LinearOperator | 
| class | LinearOpWithSpaces | 
| class | LinearSolverBase | 
| class | LinearSolverBuilder | 
| class | LinearSolver | 
| User-level linear solver object.  More... | |
| class | LineSearchBase | 
| class | DirectionGeneratorBase | 
| class | LineSearchBasedOptBase | 
| class | LineSearchBuilder | 
| class | LoadableMatrix | 
| class | LoadableVector | 
| class | MatrixFactory | 
| class | MatrixLaplacian1D | 
| class | MassMatrix1D | 
| class | MatrixMatrixTester | 
| class | MLOperator | 
| class | MPIComm | 
| Object representation of an MPI communicator.  More... | |
| class | MPIContainerComm | 
| Object representation of an MPI communicator for templated containers.  More... | |
| class | MPIContainerComm< std::string > | 
| class | MPIDataType | 
| class | MPIOp | 
| class | MPISession | 
| This class provides methods for initializing, finalizing, and querying the global MPI session.  More... | |
| class | MPITraits | 
| Templated traits class that binds MPI types to C++ types.  More... | |
| class | MPITraits< int > | 
| class | MPITraits< float > | 
| class | MPITraits< double > | 
| class | MPITraits< char > | 
| class | MultiVectorOperator | 
| class | NewtonArmijoSolver | 
| class | NonlinearOperator | 
| class | NonlinearOperatorBase | 
| class | NonlinearSolver | 
| class | NonlinearSolverBase | 
| class | NonlinearSolverBuilder | 
| class | NOXSolver | 
| class | ObjectiveBase | 
| class | ObjectWithVerbosity | 
| class | OperatorBuilder | 
| class | OptBuilder | 
| class | OptConvergenceTestBase | 
| class | OptConvergenceTestBuilder | 
| class | OptState | 
| class | Out | 
| class | ParameterListPreconditionerFactory | 
| class | PoissonBoltzmannJacobian | 
| class | PoissonBoltzmannOp | 
| class | Preconditioner | 
| Preconditioner stores left and/or right operators for use in preconditioning.  More... | |
| class | PreconditionerBase | 
| class | PreconditionerFactory | 
| class | PreconditionerFactoryBase | 
| class | Printable | 
| class | Rand | 
| class | RandomBlockMatrixBuilder | 
| class | RandomSparseMatrixBuilder | 
| class | RowAccessibleOp | 
| class | SerialGhostImporter | 
| class | SerialGhostView | 
| class | SerialVector | 
| class | SerialVectorSpace | 
| class | SerialVectorType | 
| class | SimpleAddedOp | 
| class | SimpleBacktracking | 
| class | SimpleBlockOp | 
| class | SimpleComposedOp | 
| class | SimpleDiagonalOp | 
| class | SimpleIdentityOp | 
| class | SimpleScaledOp | 
| class | SimpleTransposedOp | 
| class | SimpleZeroOp | 
| class | SingleChunkVector | 
| class | SolverState | 
| class | SteepestDescent | 
| class | SteepestDescentDirection | 
| class | Tabs | 
| class | TesterBase | 
| class | TestSpecifier | 
| class | UnconstrainedOptimizerBase | 
| class | VectorBase | 
| class | Vector | 
| class | VectorSpaceBase | 
| class | VectorSpace | 
| class | VectorTester | 
| class | VectorType | 
| Vector type objects are used by the application code to create vector spaces and operators of a given type.  More... | |
| class | VectorTypeBase | 
Enumerations | |
| enum | LeftOrRight { Left, Right } | 
| enum | LineSearchStatus { LS_Success, LS_ExceededMaxiters, LS_StepTooSmall, LS_Crashed } | 
| enum | OptStatus {  Opt_Continue, Opt_Converged, Opt_DirectionFailure, Opt_ExceededMaxiters, Opt_LineSearchFailed, Opt_Crashed }  | 
| enum | SolverStatusCode { SolveCrashed, SolveFailedToConverge, SolveConverged } | 
Functions | |
| SolverState< double > | denseSolve (const LinearOperator< double > &A, const Vector< double > &b, Vector< double > &x) | 
| void | denseSVD (const LinearOperator< double > &A, LinearOperator< double > &U, Vector< double > &Sigma, LinearOperator< double > &Vt) | 
| LinearOperator< double > | epetraLeftScale (const Vector< double > &d, const LinearOperator< double > &A) | 
| LinearOperator< double > | epetraRightScale (const LinearOperator< double > &A, const Vector< double > &d) | 
| LinearOperator< double > | epetraMatrixMatrixProduct (const LinearOperator< double > &A, const LinearOperator< double > &B) | 
| LinearOperator< double > | epetraMatrixMatrixSum (const LinearOperator< double > &A, const LinearOperator< double > &B) | 
| Vector< double > | getEpetraDiagonal (const LinearOperator< double > &A) | 
| LinearOperator< double > | makeEpetraDiagonalMatrix (const Vector< double > &d) | 
| bool | globalAnd (bool localVal) | 
| template<class PointerType > | |
| std::ostream & | operator<< (std::ostream &os, const Playa::Handle< PointerType > &h) | 
| template<class Scalar > | |
| LinearOperator< Scalar > | inverse (const LinearOperator< Scalar > &op, const LinearSolver< Scalar > &solver) | 
| Implicit inverse operator.   | |
| template<class Scalar , int N> | |
| std::ostream & | operator<< (std::ostream &os, const LCN< Scalar, N > &lc) | 
| template<class Scalar > | |
| Vector< Scalar > | operator* (const LinearOperator< Scalar > &A, const Vector< Scalar > &x) | 
| template<class Scalar , int N> | |
| Vector< Scalar > | operator* (const LinearOperator< Scalar > &A, const LCN< Scalar, N > &x) | 
| template<class Scalar > | |
| Vector< Scalar > | operator* (const LinearOperator< Scalar > &A, const LCN< Scalar, 1 > &x) | 
| template<class Scalar , int N> | |
| LCN< Scalar, N > | operator* (const LCN< Scalar, N > &lc, const Scalar &beta) | 
| template<class Scalar , int N> | |
| LCN< Scalar, N > | operator* (const Scalar &beta, const LCN< Scalar, N > &lc) | 
| template<class Scalar , int N> | |
| LCN< Scalar, N > | operator/ (const LCN< Scalar, N > &lc, const Scalar &beta) | 
| template<class Scalar > | |
| LCN< Scalar, 2 > | operator+ (const Vector< Scalar > &x, const Vector< Scalar > &y) | 
| template<class Scalar > | |
| LCN< Scalar, 2 > | operator- (const Vector< Scalar > &x, const Vector< Scalar > &y) | 
| template<class Scalar , int N, int M> | |
| LCN< Scalar, N+M > | operator+ (const LCN< Scalar, N > &f, const LCN< Scalar, M > &g) | 
| template<class Scalar , int N> | |
| LCN< Scalar, N+1 > | operator+ (const LCN< Scalar, N > &f, const Vector< Scalar > &g) | 
| template<class Scalar , int N> | |
| LCN< Scalar, N+1 > | operator+ (const Vector< Scalar > &f, const LCN< Scalar, N > &g) | 
| template<class Scalar > | |
| LCN< Scalar, 2 > | operator+ (const LCN< Scalar, 1 > &lc, const Vector< Scalar > &x) | 
| template<class Scalar > | |
| LCN< Scalar, 2 > | operator+ (const Vector< Scalar > &x, const LCN< Scalar, 1 > &lc) | 
| template<class Scalar > | |
| LCN< Scalar, 2 > | operator+ (const LCN< Scalar, 1 > &ax, const LCN< Scalar, 1 > &by) | 
| template<class Scalar > | |
| LCN< Scalar, 3 > | operator+ (const LCN< Scalar, 1 > &ax, const LCN< Scalar, 2 > &bycz) | 
| template<class Scalar > | |
| LCN< Scalar, 3 > | operator+ (const Vector< Scalar > &x, const LCN< Scalar, 2 > &bycz) | 
| template<class Scalar > | |
| LCN< Scalar, 3 > | operator+ (const LCN< Scalar, 2 > &axby, const LCN< Scalar, 1 > &cz) | 
| template<class Scalar > | |
| LCN< Scalar, 3 > | operator+ (const LCN< Scalar, 2 > &axby, const Vector< Scalar > &z) | 
| template<class Scalar , int N, int M> | |
| LCN< Scalar, N+M > | operator- (const LCN< Scalar, N > &f, const LCN< Scalar, M > &g) | 
| template<class Scalar , int N> | |
| LCN< Scalar, N+1 > | operator- (const LCN< Scalar, N > &f, const Vector< Scalar > &g) | 
| template<class Scalar , int N> | |
| LCN< Scalar, N+1 > | operator- (const Vector< Scalar > &f, const LCN< Scalar, N > &g) | 
| template<class Scalar > | |
| LCN< Scalar, 2 > | operator- (const LCN< Scalar, 1 > &lc, const Vector< Scalar > &x) | 
| template<class Scalar > | |
| LCN< Scalar, 2 > | operator- (const Vector< Scalar > &x, const LCN< Scalar, 1 > &lc) | 
| template<class Scalar > | |
| LCN< Scalar, 2 > | operator- (const LCN< Scalar, 1 > &ax, const LCN< Scalar, 1 > &by) | 
| template<class Scalar > | |
| LCN< Scalar, 3 > | operator- (const LCN< Scalar, 1 > &ax, const LCN< Scalar, 2 > &bycz) | 
| template<class Scalar > | |
| LCN< Scalar, 3 > | operator- (const Vector< Scalar > &x, const LCN< Scalar, 2 > &bycz) | 
| template<class Scalar > | |
| LCN< Scalar, 3 > | operator- (const LCN< Scalar, 2 > &axby, const LCN< Scalar, 1 > &cz) | 
| template<class Scalar > | |
| LCN< Scalar, 3 > | operator- (const LCN< Scalar, 2 > &axby, const Vector< Scalar > &z) | 
| template<class Scalar , int N> | |
| Scalar | norm1 (const LCN< Scalar, N > &lc) | 
| template<class Scalar , int N> | |
| Scalar | norm2 (const LCN< Scalar, N > &lc) | 
| template<class Scalar , int N> | |
| Scalar | normInf (const LCN< Scalar, N > &lc) | 
| template<class Scalar , int N> | |
| Vector< Scalar > | abs (const LCN< Scalar, N > &lc) | 
| template<class Scalar , int N> | |
| Scalar | min (const LCN< Scalar, N > &lc) | 
| template<class Scalar , int N> | |
| Scalar | max (const LCN< Scalar, N > &lc) | 
| template<class Scalar , int N> | |
| Vector< Scalar > | reciprocal (const LCN< Scalar, N > &lc) | 
| template<class Scalar > | |
| LCN< Scalar, 1 > | operator* (const Scalar &alpha, const Vector< Scalar > &x) | 
| template<class Scalar > | |
| LCN< Scalar, 1 > | operator* (const Vector< Scalar > &x, const Scalar &alpha) | 
| template<class Scalar > | |
| LCN< Scalar, 1 > | operator/ (const Vector< Scalar > &x, const Scalar &alpha) | 
| template<class Scalar > | |
| LinearOperator< Scalar > | multiVectorOperator (const Teuchos::Array< Vector< Scalar > > &cols, const VectorSpace< Scalar > &domain) | 
| void | writeTable (std::ostream &os, const Tabs &tab, const Array< double > &a, int cols) | 
| void | writeTable (std::ostream &os, const Tabs &tab, const Array< int > &a, int cols) | 
| template<class Scalar > | |
| LinearOperator< Scalar > | addedOperator (const Array< LinearOperator< Scalar > > &ops) | 
| template<class Scalar > | |
| LinearOperator< Scalar > | operator+ (const LinearOperator< Scalar > &A, const LinearOperator< Scalar > &B) | 
| template<class Scalar > | |
| LinearOperator< Scalar > | makeBlockOperator (const VectorSpace< Scalar > &domain, const VectorSpace< Scalar > &range) | 
| template<class Scalar > | |
| LinearOperator< Scalar > | composedOperator (const Array< LinearOperator< Scalar > > &ops) | 
| template<class Scalar > | |
| LinearOperator< Scalar > | operator* (const LinearOperator< Scalar > &A, const LinearOperator< Scalar > &B) | 
| template<class Scalar > | |
| LinearOperator< Scalar > | diagonalOperator (const Vector< Scalar > &diag) | 
| template<class Scalar > | |
| LinearOperator< Scalar > | identityOperator (const VectorSpace< Scalar > &space) | 
| template<class Scalar > | |
| LinearOperator< Scalar > | operator* (const Scalar &a, const LinearOperator< Scalar > &A) | 
| template<class Scalar > | |
| LinearOperator< Scalar > | scaledOperator (const Scalar &scale, const LinearOperator< Scalar > &op) | 
| template<class Scalar > | |
| LinearOperator< Scalar > | transposedOperator (const LinearOperator< Scalar > &op) | 
| template<class Scalar > | |
| LinearOperator< Scalar > | zeroOperator (const VectorSpace< Scalar > &domain, const VectorSpace< Scalar > &range) | 
| template<class Scalar > | |
| std::ostream & | operator<< (std::ostream &os, const Playa::SolverState< Scalar > &state) | 
| template<class Scalar > | |
| Scalar * | dataPtr (Vector< Scalar > vec) | 
| template<class Scalar > | |
| const Scalar * | dataPtr (const Vector< Scalar > &vec) | 
| template<class Scalar > | |
| LoadableVector< Scalar > * | loadable (Vector< Scalar > vec) | 
| template<class Scalar > | |
| Scalar | minloc (const Vector< Scalar > &x, int &gni) | 
| template<class Scalar > | |
| Scalar | maxloc (const Vector< Scalar > &x, int &gni) | 
| template<class Scalar > | |
| Scalar | minlocWithBound (const Scalar &lowerBound, const Vector< Scalar > &x, int &gni) | 
| template<class Scalar > | |
| Scalar | maxlocWithBound (const Scalar &upperBound, const Vector< Scalar > &x, int &gni) | 
| template<class Scalar > | |
| Scalar | norm2Dist (const Vector< Scalar > &x, const Vector< Scalar > &y) | 
| template<class Scalar > | |
| Scalar | norm1Dist (const Vector< Scalar > &x, const Vector< Scalar > &y) | 
| template<class Scalar > | |
| Scalar | normInfDist (const Vector< Scalar > &x, const Vector< Scalar > &y) | 
| static Time & | createVecTimer () | 
| enum Playa::LeftOrRight | 
Definition at line 15 of file PlayaLineSearchBase.hpp.
| enum Playa::OptStatus | 
OptStatus provides diagnostic information on the current state of an optimization run.
| Opt_Continue | |
| Opt_Converged | |
| Opt_DirectionFailure | |
| Opt_ExceededMaxiters | |
| Opt_LineSearchFailed | |
| Opt_Crashed | 
Definition at line 14 of file PlayaOptState.hpp.
SolverStatusCode is an enum that encapsulates whether a solver succeeded or failed
Definition at line 20 of file PlayaSolverState.hpp.
| Vector< Scalar > Playa::abs | ( | const LCN< Scalar, N > & | lc | ) |  [inline] | 
        
Definition at line 652 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::abs().
Referenced by Sundance::pSet(), and Sundance::weightedOrderedPartitions().
| LinearOperator<Scalar> Playa::addedOperator | ( | const Array< LinearOperator< Scalar > > & | ops | ) |  [related] | 
        
Definition at line 94 of file PlayaSimpleAddedOpImpl.hpp.
References Playa::Handle< LinearOperatorBase< Scalar > >::ptr().
Referenced by operator+().
| LinearOperator< Scalar > Playa::composedOperator | ( | const Array< LinearOperator< Scalar > > & | ops | ) |  [inline] | 
        
Definition at line 128 of file PlayaSimpleComposedOpImpl.hpp.
References Playa::Handle< LinearOperatorBase< Scalar > >::ptr(), and zeroOperator().
Referenced by operator*().
| static Time& Playa::createVecTimer | ( | ) |  [inline, static] | 
        
Definition at line 25 of file PlayaVectorSpaceImpl.hpp.
| const Scalar* Playa::dataPtr | ( | const Vector< Scalar > & | vec | ) |  [related] | 
        
Definition at line 907 of file PlayaVectorImpl.hpp.
References Playa::SingleChunkVector< Scalar >::dataPtr(), and Playa::Handle< VectorBase< Scalar > >::ptr().
| Scalar* Playa::dataPtr | ( | Vector< Scalar > | vec | ) |  [related] | 
        
Definition at line 895 of file PlayaVectorImpl.hpp.
References Playa::SingleChunkVector< Scalar >::dataPtr(), and Playa::Handle< VectorBase< Scalar > >::ptr().
| SolverState<double> Playa::denseSolve | ( | const LinearOperator< double > & | A, | |
| const Vector< double > & | b, | |||
| Vector< double > & | x | |||
| ) |  [related] | 
        
Definition at line 122 of file PlayaDenseSerialMatrix.cpp.
References Playa::Vector< Scalar >::copy(), Playa::SerialVector::dataPtr(), Playa::DenseSerialMatrix::dataPtr(), dgesv_(), Playa::DenseSerialMatrix::numRows(), Playa::Handle< PointerType >::ptr(), SolveConverged, SolveCrashed, and Teuchos::toString().
Referenced by Playa::DenseLUSolver::solve().
| void Playa::denseSVD | ( | const LinearOperator< double > & | A, | |
| LinearOperator< double > & | U, | |||
| Vector< double > & | Sigma, | |||
| LinearOperator< double > & | Vt | |||
| ) |  [related] | 
        
Definition at line 159 of file PlayaDenseSerialMatrix.cpp.
References Playa::DenseSerialMatrixFactory::createMatrix(), Playa::VectorSpace< Scalar >::createMember(), Playa::SerialVector::dataPtr(), Playa::DenseSerialMatrix::dataPtr(), dgesvd_(), Playa::LinearOperator< Scalar >::domain(), max(), min(), Playa::DenseSerialMatrix::numCols(), Playa::DenseSerialMatrix::numRows(), Playa::Handle< PointerType >::ptr(), and Playa::LinearOperator< Scalar >::range().
| LinearOperator<Scalar> Playa::diagonalOperator | ( | const Vector< Scalar > & | diag | ) |  [related] | 
        
Definition at line 75 of file PlayaSimpleDiagonalOpImpl.hpp.
Referenced by Playa::MatrixMatrixTester< Scalar >::diagLeftProdTest(), Playa::MatrixMatrixTester< Scalar >::diagRightProdTest(), Playa::MatrixMatrixTester< Scalar >::diagTest(), Playa::CompoundTester< Scalar >::diagTest(), and Sundance::LinearEigenproblem::lumpedOperator().
| LinearOperator<double> Playa::epetraLeftScale | ( | const Vector< double > & | d, | |
| const LinearOperator< double > & | A | |||
| ) |  [related] | 
        
Definition at line 23 of file PlayaEpetraMatrixMatrixProduct.cpp.
References Playa::LinearOperator< Scalar >::domain(), Playa::EpetraVector::getConcrete(), Playa::EpetraMatrix::getConcretePtr(), and Playa::LinearOperator< Scalar >::range().
Referenced by Playa::MatrixMatrixTester< Scalar >::diagLeftProdTest().
| LinearOperator<double> Playa::epetraMatrixMatrixProduct | ( | const LinearOperator< double > & | A, | |
| const LinearOperator< double > & | B | |||
| ) |  [related] | 
        
Definition at line 73 of file PlayaEpetraMatrixMatrixProduct.cpp.
References Playa::LinearOperator< Scalar >::domain(), Playa::EpetraMatrix::getConcretePtr(), and Playa::LinearOperator< Scalar >::range().
Referenced by Playa::MatrixMatrixTester< Scalar >::prodTest().
| LinearOperator<double> Playa::epetraMatrixMatrixSum | ( | const LinearOperator< double > & | A, | |
| const LinearOperator< double > & | B | |||
| ) |  [related] | 
        
Definition at line 23 of file PlayaEpetraMatrixMatrixSum.cpp.
References Playa::LinearOperator< Scalar >::domain(), Playa::EpetraMatrix::getConcretePtr(), and Playa::LinearOperator< Scalar >::range().
Referenced by Playa::MatrixMatrixTester< Scalar >::sumTest().
| LinearOperator<double> Playa::epetraRightScale | ( | const LinearOperator< double > & | A, | |
| const Vector< double > & | d | |||
| ) |  [related] | 
        
Definition at line 47 of file PlayaEpetraMatrixMatrixProduct.cpp.
References Playa::LinearOperator< Scalar >::domain(), Playa::EpetraVector::getConcrete(), Playa::EpetraMatrix::getConcretePtr(), and Playa::LinearOperator< Scalar >::range().
Referenced by Playa::MatrixMatrixTester< Scalar >::diagRightProdTest().
| Vector<double> Playa::getEpetraDiagonal | ( | const LinearOperator< double > & | A | ) |  [related] | 
        
Definition at line 26 of file PlayaEpetraMatrixOps.cpp.
References Playa::VectorSpace< Scalar >::createMember(), Playa::LinearOperator< Scalar >::domain(), Playa::EpetraVector::getConcretePtr(), and Playa::EpetraMatrix::getConcretePtr().
Referenced by Playa::MatrixMatrixTester< Scalar >::diagTest().
| bool Playa::globalAnd | ( | bool | localVal | ) | 
Definition at line 17 of file PlayaGlobalAnd.cpp.
| LinearOperator<Scalar> Playa::identityOperator | ( | const VectorSpace< Scalar > & | space | ) |  [related] | 
        
Definition at line 50 of file PlayaSimpleIdentityOpImpl.hpp.
Referenced by Playa::PCDPreconditionerFactory::createPreconditioner(), and Playa::LinearCombinationTester< Scalar >::selfModifyingOpTests().
| LinearOperator< Scalar > Playa::inverse | ( | const LinearOperator< Scalar > & | op, | |
| const LinearSolver< Scalar > & | solver | |||
| ) |  [inline] | 
        
Implicit inverse operator.
Definition at line 90 of file PlayaInverseOperatorImpl.hpp.
References Playa::InverseOperator< Scalar >::op(), and Playa::Handle< LinearOperatorBase< Scalar > >::ptr().
Referenced by Playa::PCDPreconditionerFactory::createPreconditioner().
| LoadableVector<Scalar>* Playa::loadable | ( | Vector< Scalar > | vec | ) |  [related] | 
        
Definition at line 918 of file PlayaVectorImpl.hpp.
References Playa::Handle< VectorBase< Scalar > >::ptr().
Referenced by Sundance::FunctionalEvaluator::fdGradientCheck(), Sundance::readNodalFields(), Sundance::readSerialGridField(), and Sundance::unfoldPeriodicDiscreteFunction().
| LinearOperator<Scalar> Playa::makeBlockOperator | ( | const VectorSpace< Scalar > & | domain, | |
| const VectorSpace< Scalar > & | range | |||
| ) |  [related] | 
        
Definition at line 119 of file PlayaSimpleBlockOpImpl.hpp.
Referenced by Playa::PCDPreconditionerFactory::createPreconditioner().
| LinearOperator<double> Playa::makeEpetraDiagonalMatrix | ( | const Vector< double > & | d | ) |  [related] | 
        
Definition at line 42 of file PlayaEpetraMatrixOps.cpp.
References Playa::VectorSpace< Scalar >::baseGlobalNaturalIndex(), Playa::VectorSpace< Scalar >::numLocalElements(), Playa::Handle< PointerType >::ptr(), and Playa::Vector< Scalar >::space().
Referenced by Playa::MatrixMatrixTester< Scalar >::diagTest().
| Scalar Playa::max | ( | const LCN< Scalar, N > & | lc | ) |  [inline] | 
        
Definition at line 666 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::max().
Referenced by Sundance::SparsitySuperset::addDeriv(), denseSVD(), Sundance::IntegralGroup::findIntegrationVerb(), Sundance::IntegralGroup::findTransformVerb(), Sundance::FunctionSupportResolver::FunctionSupportResolver(), Playa::MPIContainerComm< std::string >::gatherv(), Sundance::EquationSet::init(), main(), Sundance::EvaluatableExpr::maxOrder(), Sundance::ReducedIntegral::ReducedIntegral(), Sundance::RefIntegral::RefIntegral(), Sundance::DoublingStepController::run(), and Playa::DefaultOptConvergenceTest::test().
| Scalar Playa::maxloc | ( | const Vector< Scalar > & | x, | |
| int & | gni | |||
| ) |  [related] | 
        
| Scalar Playa::maxlocWithBound | ( | const Scalar & | upperBound, | |
| const Vector< Scalar > & | x, | |||
| int & | gni | |||
| ) |  [related] | 
        
Definition at line 59 of file PlayaVectorOpsImpl.hpp.
References Playa::Vector< Scalar >::applyUnaryReductionFunctor(), Playa::Vector< Scalar >::comm(), Playa::Vector< Scalar >::space(), PlayaFunctors::IndexedValue< Scalar >::what, and PlayaFunctors::IndexedValue< Scalar >::where.
Referenced by maxloc().
| Scalar Playa::min | ( | const LCN< Scalar, N > & | lc | ) |  [inline] | 
        
Definition at line 659 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::min().
Referenced by denseSVD(), Playa::BlockIterator< Scalar >::operator<(), and Sundance::DoublingStepController::run().
| Scalar Playa::minloc | ( | const Vector< Scalar > & | x, | |
| int & | gni | |||
| ) |  [related] | 
        
| Scalar Playa::minlocWithBound | ( | const Scalar & | lowerBound, | |
| const Vector< Scalar > & | x, | |||
| int & | gni | |||
| ) |  [related] | 
        
Definition at line 48 of file PlayaVectorOpsImpl.hpp.
References Playa::Vector< Scalar >::applyUnaryReductionFunctor(), Playa::Vector< Scalar >::comm(), Playa::Vector< Scalar >::space(), PlayaFunctors::IndexedValue< Scalar >::what, and PlayaFunctors::IndexedValue< Scalar >::where.
Referenced by minloc().
| LinearOperator<Scalar> Playa::multiVectorOperator | ( | const Teuchos::Array< Vector< Scalar > > & | cols, | |
| const VectorSpace< Scalar > & | domain | |||
| ) |  [related] | 
        
Definition at line 93 of file PlayaMultiVectorOperatorImpl.hpp.
| Scalar Playa::norm1 | ( | const LCN< Scalar, N > & | lc | ) |  [inline] | 
        
Definition at line 631 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::norm1().
| Scalar Playa::norm1Dist | ( | const Vector< Scalar > & | x, | |
| const Vector< Scalar > & | y | |||
| ) |  [related] | 
        
Definition at line 79 of file PlayaVectorOpsImpl.hpp.
References Playa::Vector< Scalar >::applyBinaryReductionFunctor(), and Playa::Vector< Scalar >::comm().
| Scalar Playa::norm2 | ( | const LCN< Scalar, N > & | lc | ) |  [inline] | 
        
Definition at line 638 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::norm2().
Referenced by Playa::CompoundTester< Scalar >::composedTest(), Playa::MatrixMatrixTester< Scalar >::diagLeftProdTest(), Playa::MatrixMatrixTester< Scalar >::diagRightProdTest(), Playa::MatrixMatrixTester< Scalar >::diagTest(), Playa::CompoundTester< Scalar >::diagTest(), Sundance::DefaultExprComparison::diff(), Playa::MatrixMatrixTester< Scalar >::prodTest(), Playa::CompoundTester< Scalar >::scaledTest(), Playa::LinearCombinationTester< Scalar >::selfModifyingOpTests(), Sundance::StochBlockJacobiSolver::solve(), Playa::MatrixMatrixTester< Scalar >::sumTest(), and Playa::CompoundTester< Scalar >::sumTest().
| Scalar Playa::norm2Dist | ( | const Vector< Scalar > & | x, | |
| const Vector< Scalar > & | y | |||
| ) |  [related] | 
        
Definition at line 71 of file PlayaVectorOpsImpl.hpp.
References Playa::Vector< Scalar >::applyBinaryReductionFunctor(), and Playa::Vector< Scalar >::comm().
| Scalar Playa::normInf | ( | const LCN< Scalar, N > & | lc | ) |  [inline] | 
        
Definition at line 645 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::normInf().
Referenced by Playa::VectorTester< Scalar >::dotSlashTest(), Playa::VectorTester< Scalar >::dotStarTest(), Playa::VectorTester< Scalar >::overloadedUpdateTest(), Playa::VectorTester< Scalar >::scalarMultTest(), Playa::VectorTester< Scalar >::sumTest(), and Playa::DefaultOptConvergenceTest::test().
| Scalar Playa::normInfDist | ( | const Vector< Scalar > & | x, | |
| const Vector< Scalar > & | y | |||
| ) |  [related] | 
        
Definition at line 87 of file PlayaVectorOpsImpl.hpp.
References Playa::Vector< Scalar >::applyBinaryReductionFunctor(), and Playa::Vector< Scalar >::comm().
| LinearOperator< Scalar > Playa::operator* | ( | const Scalar & | a, | |
| const LinearOperator< Scalar > & | A | |||
| ) |  [inline] | 
        
| LinearOperator< Scalar > Playa::operator* | ( | const LinearOperator< Scalar > & | A, | |
| const LinearOperator< Scalar > & | B | |||
| ) |  [inline] | 
        
| LCN<Scalar, 1> Playa::operator* | ( | const Vector< Scalar > & | x, | |
| const Scalar & | alpha | |||
| ) |  [related] | 
        
Definition at line 330 of file PlayaLinearCombinationImpl.hpp.
| LCN<Scalar, 1> Playa::operator* | ( | const Scalar & | alpha, | |
| const Vector< Scalar > & | x | |||
| ) |  [related] | 
        
Definition at line 322 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, N > Playa::operator* | ( | const Scalar & | beta, | |
| const LCN< Scalar, N > & | lc | |||
| ) |  [inline] | 
        
Definition at line 365 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::multiply().
| LCN< Scalar, N > Playa::operator* | ( | const LCN< Scalar, N > & | lc, | |
| const Scalar & | beta | |||
| ) |  [inline] | 
        
Definition at line 356 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::multiply().
| Vector< Scalar > Playa::operator* | ( | const LinearOperator< Scalar > & | A, | |
| const LCN< Scalar, 1 > & | x | |||
| ) |  [inline] | 
        
Definition at line 304 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::coeff(), Playa::Vector< Scalar >::scale(), and Playa::LCNBase< Scalar, N >::vec().
| Vector< Scalar > Playa::operator* | ( | const LinearOperator< Scalar > & | A, | |
| const LCN< Scalar, N > & | x | |||
| ) |  [inline] | 
        
Definition at line 296 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCN< Scalar, N >::eval().
| Vector< Scalar > Playa::operator* | ( | const LinearOperator< Scalar > & | A, | |
| const Vector< Scalar > & | x | |||
| ) |  [inline] | 
        
Definition at line 285 of file PlayaLinearCombinationImpl.hpp.
References Playa::LinearOperator< Scalar >::apply().
| LinearOperator<Scalar> Playa::operator+ | ( | const LinearOperator< Scalar > & | A, | |
| const LinearOperator< Scalar > & | B | |||
| ) |  [related] | 
        
| LCN< Scalar, 3 > Playa::operator+ | ( | const LCN< Scalar, 2 > & | axby, | |
| const Vector< Scalar > & | z | |||
| ) |  [inline] | 
        
Definition at line 508 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, 3 > Playa::operator+ | ( | const LCN< Scalar, 2 > & | axby, | |
| const LCN< Scalar, 1 > & | cz | |||
| ) |  [inline] | 
        
Definition at line 499 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, 3 > Playa::operator+ | ( | const Vector< Scalar > & | x, | |
| const LCN< Scalar, 2 > & | bycz | |||
| ) |  [inline] | 
        
Definition at line 489 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, 3 > Playa::operator+ | ( | const LCN< Scalar, 1 > & | ax, | |
| const LCN< Scalar, 2 > & | bycz | |||
| ) |  [inline] | 
        
Definition at line 481 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, 2 > Playa::operator+ | ( | const LCN< Scalar, 1 > & | ax, | |
| const LCN< Scalar, 1 > & | by | |||
| ) |  [inline] | 
        
Definition at line 472 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, 2 > Playa::operator+ | ( | const Vector< Scalar > & | x, | |
| const LCN< Scalar, 1 > & | lc | |||
| ) |  [inline] | 
        
Definition at line 463 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, 2 > Playa::operator+ | ( | const LCN< Scalar, 1 > & | lc, | |
| const Vector< Scalar > & | x | |||
| ) |  [inline] | 
        
Definition at line 453 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, N+1 > Playa::operator+ | ( | const Vector< Scalar > & | f, | |
| const LCN< Scalar, N > & | g | |||
| ) |  [inline] | 
        
Definition at line 440 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::coeff(), Playa::LCN< Scalar, N >::set(), and Playa::LCNBase< Scalar, N >::vec().
| LCN< Scalar, N+1 > Playa::operator+ | ( | const LCN< Scalar, N > & | f, | |
| const Vector< Scalar > & | g | |||
| ) |  [inline] | 
        
Definition at line 429 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::coeff(), Playa::LCN< Scalar, N >::set(), and Playa::LCNBase< Scalar, N >::vec().
| LCN< Scalar, N+M > Playa::operator+ | ( | const LCN< Scalar, N > & | f, | |
| const LCN< Scalar, M > & | g | |||
| ) |  [inline] | 
        
Definition at line 419 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::coeff(), Playa::LCN< Scalar, N >::set(), and Playa::LCNBase< Scalar, N >::vec().
| LCN< Scalar, 2 > Playa::operator+ | ( | const Vector< Scalar > & | x, | |
| const Vector< Scalar > & | y | |||
| ) |  [inline] | 
        
Definition at line 393 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, 3 > Playa::operator- | ( | const LCN< Scalar, 2 > & | axby, | |
| const Vector< Scalar > & | z | |||
| ) |  [inline] | 
        
Definition at line 614 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, 3 > Playa::operator- | ( | const LCN< Scalar, 2 > & | axby, | |
| const LCN< Scalar, 1 > & | cz | |||
| ) |  [inline] | 
        
Definition at line 605 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, 3 > Playa::operator- | ( | const Vector< Scalar > & | x, | |
| const LCN< Scalar, 2 > & | bycz | |||
| ) |  [inline] | 
        
Definition at line 595 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, 3 > Playa::operator- | ( | const LCN< Scalar, 1 > & | ax, | |
| const LCN< Scalar, 2 > & | bycz | |||
| ) |  [inline] | 
        
Definition at line 587 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, 2 > Playa::operator- | ( | const LCN< Scalar, 1 > & | ax, | |
| const LCN< Scalar, 1 > & | by | |||
| ) |  [inline] | 
        
Definition at line 578 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, 2 > Playa::operator- | ( | const Vector< Scalar > & | x, | |
| const LCN< Scalar, 1 > & | lc | |||
| ) |  [inline] | 
        
Definition at line 569 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::coeff(), and Playa::LCNBase< Scalar, N >::vec().
| LCN< Scalar, 2 > Playa::operator- | ( | const LCN< Scalar, 1 > & | lc, | |
| const Vector< Scalar > & | x | |||
| ) |  [inline] | 
        
Definition at line 559 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, N+1 > Playa::operator- | ( | const Vector< Scalar > & | f, | |
| const LCN< Scalar, N > & | g | |||
| ) |  [inline] | 
        
Definition at line 546 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::coeff(), Playa::LCN< Scalar, N >::set(), and Playa::LCNBase< Scalar, N >::vec().
| LCN< Scalar, N+1 > Playa::operator- | ( | const LCN< Scalar, N > & | f, | |
| const Vector< Scalar > & | g | |||
| ) |  [inline] | 
        
Definition at line 535 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::coeff(), Playa::LCN< Scalar, N >::set(), and Playa::LCNBase< Scalar, N >::vec().
| LCN< Scalar, N+M > Playa::operator- | ( | const LCN< Scalar, N > & | f, | |
| const LCN< Scalar, M > & | g | |||
| ) |  [inline] | 
        
Definition at line 525 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::coeff(), Playa::LCN< Scalar, N >::set(), and Playa::LCNBase< Scalar, N >::vec().
| LCN< Scalar, 2 > Playa::operator- | ( | const Vector< Scalar > & | x, | |
| const Vector< Scalar > & | y | |||
| ) |  [inline] | 
        
Definition at line 402 of file PlayaLinearCombinationImpl.hpp.
| LCN<Scalar, 1> Playa::operator/ | ( | const Vector< Scalar > & | x, | |
| const Scalar & | alpha | |||
| ) |  [related] | 
        
Definition at line 339 of file PlayaLinearCombinationImpl.hpp.
| LCN< Scalar, N > Playa::operator/ | ( | const LCN< Scalar, N > & | lc, | |
| const Scalar & | beta | |||
| ) |  [inline] | 
        
Definition at line 374 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::multiply().
| std::ostream& Playa::operator<< | ( | std::ostream & | os, | |
| const Playa::SolverState< Scalar > & | state | |||
| ) |  [inline] | 
        
Definition at line 82 of file PlayaSolverState.hpp.
References Playa::SolverState< Scalar >::finalIters(), Playa::SolverState< Scalar >::finalMsg(), Playa::SolverState< Scalar >::finalResid(), and Playa::SolverState< Scalar >::stateDescription().
| std::ostream& Playa::operator<< | ( | std::ostream & | os, | |
| const LCN< Scalar, N > & | lc | |||
| ) |  [inline] | 
        
Definition at line 267 of file PlayaLinearCombinationDecl.hpp.
References Playa::Vector< Scalar >::description().
| std::ostream& Playa::operator<< | ( | std::ostream & | os, | |
| const Playa::Handle< PointerType > & | h | |||
| ) |  [inline] | 
        
Definition at line 181 of file PlayaHandle.hpp.
| Vector< Scalar > Playa::reciprocal | ( | const LCN< Scalar, N > & | lc | ) |  [inline] | 
        
Definition at line 673 of file PlayaLinearCombinationImpl.hpp.
References Playa::LCNBase< Scalar, N >::reciprocal().
| LinearOperator<Scalar> Playa::scaledOperator | ( | const Scalar & | scale, | |
| const LinearOperator< Scalar > & | op | |||
| ) |  [related] | 
        
| LinearOperator<Scalar> Playa::transposedOperator | ( | const LinearOperator< Scalar > & | op | ) |  [related] | 
        
Definition at line 69 of file PlayaSimpleTransposedOpImpl.hpp.
References Playa::LinearOperator< Scalar >::domain(), Playa::SimpleTransposedOp< Scalar >::op(), Playa::Handle< LinearOperatorBase< Scalar > >::ptr(), Playa::LinearOperator< Scalar >::range(), and zeroOperator().
Referenced by Playa::LinearOperator< Scalar >::transpose().
| void Playa::writeTable | ( | std::ostream & | os, | |
| const Tabs & | tab, | |||
| const Array< int > & | a, | |||
| int | cols | |||
| ) | 
Write an array formatted to show a specified number of columns
Definition at line 75 of file PlayaOut.cpp.
| void Playa::writeTable | ( | std::ostream & | os, | |
| const Tabs & | tab, | |||
| const Array< double > & | a, | |||
| int | cols | |||
| ) | 
Write an array formatted to show a specified number of columns
Definition at line 54 of file PlayaOut.cpp.
| LinearOperator<Scalar> Playa::zeroOperator | ( | const VectorSpace< Scalar > & | domain, | |
| const VectorSpace< Scalar > & | range | |||
| ) |  [related] | 
        
Definition at line 59 of file PlayaSimpleZeroOpImpl.hpp.
Referenced by composedOperator(), Playa::SimpleBlockOp< Scalar >::SimpleBlockOp(), and transposedOperator().