EpetraExt  Development
Public Member Functions | List of all members
GLpApp::GLpYUEpetraDataPool Class Reference

#include <GLpApp_GLpYUEpetraDataPool.hpp>

Inheritance diagram for GLpApp::GLpYUEpetraDataPool:
Inheritance graph
[legend]

Public Member Functions

 GLpYUEpetraDataPool (Teuchos::RCP< const Epetra_Comm > const &commptr, const double beta, const double len_x, const double len_y, const int local_nx, const int local_ny, const char myfile[], const bool trace)
 
void computeAll (const GenSQP::Vector &x)
 Calls functions to compute nonlinear quantities and the augmented system matrix. More...
 
int solveAugsys (const Teuchos::RCP< const Epetra_MultiVector > &rhsy, const Teuchos::RCP< const Epetra_MultiVector > &rhsu, const Teuchos::RCP< const Epetra_MultiVector > &rhsp, const Teuchos::RCP< Epetra_MultiVector > &y, const Teuchos::RCP< Epetra_MultiVector > &u, const Teuchos::RCP< Epetra_MultiVector > &p, double tol)
 Solves augmented system. More...
 
Teuchos::RCP< const Epetra_Comm > getCommPtr ()
 
Teuchos::RCP< Epetra_FECrsMatrix > getA ()
 
Teuchos::RCP< Epetra_FECrsMatrix > getB ()
 
Teuchos::RCP< Epetra_FECrsMatrix > getH ()
 
Teuchos::RCP< Epetra_FECrsMatrix > getR ()
 
Teuchos::RCP< Epetra_CrsMatrix > getAugmat ()
 
Teuchos::RCP< Epetra_FECrsMatrix > getNpy ()
 
Teuchos::RCP< Epetra_FEVector > getb ()
 
Teuchos::RCP< Epetra_FEVector > getq ()
 
Teuchos::RCP< Epetra_FEVector > getNy ()
 
void computeNy (const Teuchos::RCP< const Epetra_MultiVector > &y)
 Calls the function that computes the nonlinear term. More...
 
void computeNpy (const Teuchos::RCP< const Epetra_MultiVector > &y)
 Calls the function that computes the Jacobian of the nonlinear term. More...
 
void computeAugmat ()
 Assembles the augmented system (KKT-type) matrix. More...
 
Teuchos::RCP< const Epetra_SerialDenseMatrix > getipcoords ()
 
Teuchos::RCP< const Epetra_IntSerialDenseVector > getipindx ()
 
Teuchos::RCP< const Epetra_SerialDenseMatrix > getpcoords ()
 
Teuchos::RCP< const Epetra_IntSerialDenseVector > getpindx ()
 
Teuchos::RCP< const Epetra_IntSerialDenseMatrix > gett ()
 
Teuchos::RCP< const Epetra_IntSerialDenseMatrix > gete ()
 
double getbeta ()
 
void PrintVec (const Teuchos::RCP< const Epetra_Vector > &x)
 Outputs the solution vector to files. More...
 
- Public Member Functions inherited from GenSQP::DataPool
virtual ~DataPool ()
 

Detailed Description

Definition at line 77 of file GLpApp_GLpYUEpetraDataPool.hpp.

Constructor & Destructor Documentation

◆ GLpYUEpetraDataPool()

GLpApp::GLpYUEpetraDataPool::GLpYUEpetraDataPool ( Teuchos::RCP< const Epetra_Comm > const &  commptr,
const double  beta,
const double  len_x,
const double  len_y,
const int  local_nx,
const int  local_ny,
const char  myfile[],
const bool  trace 
)

Definition at line 225 of file GLpApp_GLpYUEpetraDataPool.cpp.

Member Function Documentation

◆ computeAll()

void GLpApp::GLpYUEpetraDataPool::computeAll ( const GenSQP::Vector x)
virtual

Calls functions to compute nonlinear quantities and the augmented system matrix.

These computations are performed after every update of the SQP iterate.

Implements GenSQP::DataPool.

Definition at line 277 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ solveAugsys()

int GLpApp::GLpYUEpetraDataPool::solveAugsys ( const Teuchos::RCP< const Epetra_MultiVector > &  rhsy,
const Teuchos::RCP< const Epetra_MultiVector > &  rhsu,
const Teuchos::RCP< const Epetra_MultiVector > &  rhsp,
const Teuchos::RCP< Epetra_MultiVector > &  y,
const Teuchos::RCP< Epetra_MultiVector > &  u,
const Teuchos::RCP< Epetra_MultiVector > &  p,
double  tol 
)

Solves augmented system.

Definition at line 292 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getCommPtr()

Teuchos::RCP< const Epetra_Comm > GLpApp::GLpYUEpetraDataPool::getCommPtr ( )

Definition at line 495 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getA()

Teuchos::RCP< Epetra_FECrsMatrix > GLpApp::GLpYUEpetraDataPool::getA ( )

Definition at line 497 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getB()

Teuchos::RCP< Epetra_FECrsMatrix > GLpApp::GLpYUEpetraDataPool::getB ( )

Definition at line 499 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getH()

Teuchos::RCP< Epetra_FECrsMatrix > GLpApp::GLpYUEpetraDataPool::getH ( )

Definition at line 501 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getR()

Teuchos::RCP< Epetra_FECrsMatrix > GLpApp::GLpYUEpetraDataPool::getR ( )

Definition at line 503 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getAugmat()

Teuchos::RCP< Epetra_CrsMatrix > GLpApp::GLpYUEpetraDataPool::getAugmat ( )

Definition at line 505 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getNpy()

Teuchos::RCP< Epetra_FECrsMatrix > GLpApp::GLpYUEpetraDataPool::getNpy ( )

Definition at line 507 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getb()

Teuchos::RCP< Epetra_FEVector > GLpApp::GLpYUEpetraDataPool::getb ( )

Definition at line 509 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getq()

Teuchos::RCP< Epetra_FEVector > GLpApp::GLpYUEpetraDataPool::getq ( )

Definition at line 511 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getNy()

Teuchos::RCP< Epetra_FEVector > GLpApp::GLpYUEpetraDataPool::getNy ( )

Definition at line 513 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ computeNy()

void GLpApp::GLpYUEpetraDataPool::computeNy ( const Teuchos::RCP< const Epetra_MultiVector > &  y)

Calls the function that computes the nonlinear term.

Definition at line 530 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ computeNpy()

void GLpApp::GLpYUEpetraDataPool::computeNpy ( const Teuchos::RCP< const Epetra_MultiVector > &  y)

Calls the function that computes the Jacobian of the nonlinear term.

Definition at line 541 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ computeAugmat()

void GLpApp::GLpYUEpetraDataPool::computeAugmat ( )

Assembles the augmented system (KKT-type) matrix.

Definition at line 552 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getipcoords()

Teuchos::RCP< const Epetra_SerialDenseMatrix > GLpApp::GLpYUEpetraDataPool::getipcoords ( )

Definition at line 517 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getipindx()

Teuchos::RCP< const Epetra_IntSerialDenseVector > GLpApp::GLpYUEpetraDataPool::getipindx ( )

Definition at line 519 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getpcoords()

Teuchos::RCP< const Epetra_SerialDenseMatrix > GLpApp::GLpYUEpetraDataPool::getpcoords ( )

Definition at line 521 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getpindx()

Teuchos::RCP< const Epetra_IntSerialDenseVector > GLpApp::GLpYUEpetraDataPool::getpindx ( )

Definition at line 523 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ gett()

Teuchos::RCP< const Epetra_IntSerialDenseMatrix > GLpApp::GLpYUEpetraDataPool::gett ( )

Definition at line 525 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ gete()

Teuchos::RCP< const Epetra_IntSerialDenseMatrix > GLpApp::GLpYUEpetraDataPool::gete ( )

Definition at line 527 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ getbeta()

double GLpApp::GLpYUEpetraDataPool::getbeta ( )

Definition at line 515 of file GLpApp_GLpYUEpetraDataPool.cpp.

◆ PrintVec()

void GLpApp::GLpYUEpetraDataPool::PrintVec ( const Teuchos::RCP< const Epetra_Vector > &  x)

Outputs the solution vector to files.

Definition at line 682 of file GLpApp_GLpYUEpetraDataPool.cpp.


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