ConstrainedOptPack: C++ Tools for Constrained (and Unconstrained) Optimization  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Groups Pages
List of all members
ConstrainedOptPack::DecompositionSystemVarReductPerm Class Referenceabstract

Specialization interface of DecompositonSystem that allows basis permutations. More...

#include <ConstrainedOptPack_DecompositionSystemVarReductPerm.hpp>

Inheritance diagram for ConstrainedOptPack::DecompositionSystemVarReductPerm:
Inheritance graph
[legend]

Public types

typedef Teuchos::RCP< const
Teuchos::AbstractFactory
< Permutation > > 
perm_fcty_ptr_t
 

Constructors / initializers

 DecompositionSystemVarReductPerm (EExplicitImplicit D_imp=MAT_IMP_AUTO, EExplicitImplicit Uz_imp=MAT_IMP_AUTO)
 

Permutation factories

virtual const perm_fcty_ptr_t factory_P_var () const =0
 
virtual const perm_fcty_ptr_t factory_P_equ () const =0
 

Setting or selecting a new decomposition

virtual bool has_basis () const =0
 Query to see if a current basis is already selected. More...
 
virtual void set_decomp (std::ostream *out, EOutputLevel olevel, ERunTests test_what, const Permutation &P_var, const Range1D &var_dep, const Permutation *P_equ, const Range1D *equ_decomp, const MatrixOp &Gc, MatrixOp *Z, MatrixOp *Y, MatrixOpNonsing *R, MatrixOp *Uz, MatrixOp *Uy, EMatRelations mat_rel=MATRICES_INDEP_IMPS)=0
 Client selects the basis for Gc(:,con_decomp)'. More...
 
virtual void select_decomp (std::ostream *out, EOutputLevel olevel, ERunTests test_what, const Vector *nu, MatrixOp *Gc, Permutation *P_var, Range1D *var_dep, Permutation *P_equ, Range1D *equ_decomp, MatrixOp *Z, MatrixOp *Y, MatrixOpNonsing *R, MatrixOp *Uz, MatrixOp *Uy, EMatRelations mat_rel=MATRICES_INDEP_IMPS)=0
 Client asks decompostion system object to select the basis for Gc(:,con_decomp)'. More...
 

Additional Inherited Members

- Public Types inherited from ConstrainedOptPack::DecompositionSystemVarReduct
enum  EExplicitImplicit
 
- Public Types inherited from ConstrainedOptPack::DecompositionSystem
enum  EOutputLevel
 Enumeration for the amount of output to create from update_decomp(). More...
 
enum  ERunTests
 Enumeration for if to run internal tests or not. More...
 
enum  EMatRelations
 
typedef Teuchos::RCP< const
Teuchos::AbstractFactory
< MatrixOpNonsing > > 
mat_nonsing_fcty_ptr_t
 
typedef Teuchos::RCP< const
Teuchos::AbstractFactory
< MatrixOp > > 
mat_fcty_ptr_t
 
- Public Member Functions inherited from ConstrainedOptPack::DecompositionSystemVarReduct
 STANDARD_MEMBER_COMPOSITION_MEMBERS (EExplicitImplicit, D_imp)
 Set whether to use explicit or implicit D = -inv(C)*N matrix. More...
 
 STANDARD_MEMBER_COMPOSITION_MEMBERS (EExplicitImplicit, Uz_imp)
 Set whether to use explicit or implicit Uz = F + E * D matrix. More...
 
 DecompositionSystemVarReduct (EExplicitImplicit D_imp=MAT_IMP_AUTO, EExplicitImplicit Uz_imp=MAT_IMP_AUTO)
 
virtual Range1D var_indep () const =0
 
virtual Range1D var_dep () const =0
 
- Public Member Functions inherited from ConstrainedOptPack::DecompositionSystem
virtual ~DecompositionSystem ()
 
virtual size_type n () const
 Return the number of rows in Gc. More...
 
virtual size_type m () const =0
 Return the number of columns in Gc. More...
 
virtual size_type r () const
 Returns the rank of Gc(:,equ_decomp()). More...
 
virtual Range1D equ_decomp () const
 Returns the range of the decomposed equalities. More...
 
virtual Range1D equ_undecomp () const
 Returns the range of the undecomposed equalities. More...
 
virtual const
VectorSpace::space_ptr_t 
space_range () const =0
 Return a VectorSpace object for the range space. More...
 
virtual const
VectorSpace::space_ptr_t 
space_null () const =0
 Return a VectorSpace object for the range space. More...
 
virtual const mat_fcty_ptr_t factory_Z () const =0
 Return a matrix factory object for Z More...
 
virtual const mat_fcty_ptr_t factory_Y () const =0
 Return a matrix factory object for Y More...
 
virtual const
mat_nonsing_fcty_ptr_t 
factory_R () const =0
 Return a matrix factory object for R. More...
 
virtual const mat_fcty_ptr_t factory_Uz () const =0
 Return a matrix factory object for Uz More...
 
virtual const mat_fcty_ptr_t factory_Uy () const =0
 Return a matrix factory object for Uy More...
 
virtual void update_decomp (std::ostream *out, EOutputLevel olevel, ERunTests test_what, const MatrixOp &Gc, MatrixOp *Z, MatrixOp *Y, MatrixOpNonsing *R, MatrixOp *Uz, MatrixOp *Vy, EMatRelations mat_rel=MATRICES_INDEP_IMPS) const =0
 Creates the range/null decomposition for Gc(:,equ_decomp)'. More...
 
virtual void print_update_decomp (std::ostream &out, const std::string &leading_str) const =0
 Print the sub-algorithm by which the decomposition is formed. More...
 

Detailed Description

Specialization interface of DecompositonSystem that allows basis permutations.

ToDo: Finish documentation!

Definition at line 56 of file ConstrainedOptPack_DecompositionSystemVarReductPerm.hpp.

Member Typedef Documentation

Constructor & Destructor Documentation

ConstrainedOptPack::DecompositionSystemVarReductPerm::DecompositionSystemVarReductPerm ( EExplicitImplicit  D_imp = MAT_IMP_AUTO,
EExplicitImplicit  Uz_imp = MAT_IMP_AUTO 
)
inline

Member Function Documentation

virtual const perm_fcty_ptr_t ConstrainedOptPack::DecompositionSystemVarReductPerm::factory_P_var ( ) const
pure virtual
virtual const perm_fcty_ptr_t ConstrainedOptPack::DecompositionSystemVarReductPerm::factory_P_equ ( ) const
pure virtual
virtual bool ConstrainedOptPack::DecompositionSystemVarReductPerm::has_basis ( ) const
pure virtual

Query to see if a current basis is already selected.

Implemented in ConstrainedOptPack::DecompositionSystemVarReductPermStd.

virtual void ConstrainedOptPack::DecompositionSystemVarReductPerm::set_decomp ( std::ostream *  out,
EOutputLevel  olevel,
ERunTests  test_what,
const Permutation &  P_var,
const Range1D &  var_dep,
const Permutation *  P_equ,
const Range1D *  equ_decomp,
const MatrixOp &  Gc,
MatrixOp *  Z,
MatrixOp *  Y,
MatrixOpNonsing *  R,
MatrixOp *  Uz,
MatrixOp *  Uy,
EMatRelations  mat_rel = MATRICES_INDEP_IMPS 
)
pure virtual

Client selects the basis for Gc(:,con_decomp)'.

ToDo: Finish documentation!

Implemented in ConstrainedOptPack::DecompositionSystemVarReductPermStd.

virtual void ConstrainedOptPack::DecompositionSystemVarReductPerm::select_decomp ( std::ostream *  out,
EOutputLevel  olevel,
ERunTests  test_what,
const Vector *  nu,
MatrixOp *  Gc,
Permutation *  P_var,
Range1D *  var_dep,
Permutation *  P_equ,
Range1D *  equ_decomp,
MatrixOp *  Z,
MatrixOp *  Y,
MatrixOpNonsing *  R,
MatrixOp *  Uz,
MatrixOp *  Uy,
EMatRelations  mat_rel = MATRICES_INDEP_IMPS 
)
pure virtual

Client asks decompostion system object to select the basis for Gc(:,con_decomp)'.

ToDo: Finish documentation!

Implemented in ConstrainedOptPack::DecompositionSystemVarReductPermStd.


The documentation for this class was generated from the following file: