EpetraExt Package Browser (Single Doxygen Collection)
Development
|
#include <GLpApp_GLpYUEpetraDataPool.hpp>
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... | |
![]() | |
virtual | ~DataPool () |
Private Attributes | |
Teuchos::RCP< const Epetra_Comm > | commptr_ |
Teuchos::RCP< Epetra_SerialDenseMatrix > | ipcoords_ |
Coordinates of nodes that are unique to this subdomain. More... | |
Teuchos::RCP< Epetra_IntSerialDenseVector > | ipindx_ |
Global nodes (interior, nonoverlapping) in this subdomain. More... | |
Teuchos::RCP< Epetra_SerialDenseMatrix > | pcoords_ |
Coordinates of all nodes in this subdomain. More... | |
Teuchos::RCP< Epetra_IntSerialDenseVector > | pindx_ |
Global nodes (interior + shared, overlapping) in this subdomain. More... | |
Teuchos::RCP< Epetra_IntSerialDenseMatrix > | t_ |
Elements (this includes all overlapping nodes). More... | |
Teuchos::RCP< Epetra_IntSerialDenseMatrix > | e_ |
Edges. More... | |
Teuchos::RCP< Epetra_FECrsMatrix > | A_ |
Volume stiffness matrix. More... | |
Teuchos::RCP< Epetra_FECrsMatrix > | B_ |
Control/state mass matrix. More... | |
Teuchos::RCP< Epetra_FECrsMatrix > | H_ |
Volume mass matrix. More... | |
Teuchos::RCP< Epetra_FECrsMatrix > | R_ |
Edge mass matrix. More... | |
Teuchos::RCP< Epetra_MultiVector > | B_bar_ |
Basis matrix for p_bar=B*p. More... | |
Teuchos::RCP< Epetra_CrsMatrix > | Augmat_ |
Augmented system matrix: [ I Jac* ] [Jac 0 ]. More... | |
Teuchos::RCP< Epetra_FECrsMatrix > | Npy_ |
Jacobian of the nonlinear term. More... | |
Teuchos::RCP< Epetra_FEVector > | b_ |
Right-hand side of the PDE. More... | |
Teuchos::RCP< Epetra_FEVector > | q_ |
The desired state. More... | |
Teuchos::RCP< Epetra_FEVector > | Ny_ |
double | beta_ |
Regularization parameter. More... | |
Definition at line 77 of file GLpApp_GLpYUEpetraDataPool.hpp.
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.
|
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.
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.
Teuchos::RCP< const Epetra_Comm > GLpApp::GLpYUEpetraDataPool::getCommPtr | ( | ) |
Definition at line 495 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< Epetra_FECrsMatrix > GLpApp::GLpYUEpetraDataPool::getA | ( | ) |
Definition at line 497 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< Epetra_FECrsMatrix > GLpApp::GLpYUEpetraDataPool::getB | ( | ) |
Definition at line 499 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< Epetra_FECrsMatrix > GLpApp::GLpYUEpetraDataPool::getH | ( | ) |
Definition at line 501 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< Epetra_FECrsMatrix > GLpApp::GLpYUEpetraDataPool::getR | ( | ) |
Definition at line 503 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< Epetra_CrsMatrix > GLpApp::GLpYUEpetraDataPool::getAugmat | ( | ) |
Definition at line 505 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< Epetra_FECrsMatrix > GLpApp::GLpYUEpetraDataPool::getNpy | ( | ) |
Definition at line 507 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< Epetra_FEVector > GLpApp::GLpYUEpetraDataPool::getb | ( | ) |
Definition at line 509 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< Epetra_FEVector > GLpApp::GLpYUEpetraDataPool::getq | ( | ) |
Definition at line 511 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< Epetra_FEVector > GLpApp::GLpYUEpetraDataPool::getNy | ( | ) |
Definition at line 513 of file GLpApp_GLpYUEpetraDataPool.cpp.
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.
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.
void GLpApp::GLpYUEpetraDataPool::computeAugmat | ( | ) |
Assembles the augmented system (KKT-type) matrix.
Definition at line 552 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< const Epetra_SerialDenseMatrix > GLpApp::GLpYUEpetraDataPool::getipcoords | ( | ) |
Definition at line 517 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< const Epetra_IntSerialDenseVector > GLpApp::GLpYUEpetraDataPool::getipindx | ( | ) |
Definition at line 519 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< const Epetra_SerialDenseMatrix > GLpApp::GLpYUEpetraDataPool::getpcoords | ( | ) |
Definition at line 521 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< const Epetra_IntSerialDenseVector > GLpApp::GLpYUEpetraDataPool::getpindx | ( | ) |
Definition at line 523 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< const Epetra_IntSerialDenseMatrix > GLpApp::GLpYUEpetraDataPool::gett | ( | ) |
Definition at line 525 of file GLpApp_GLpYUEpetraDataPool.cpp.
Teuchos::RCP< const Epetra_IntSerialDenseMatrix > GLpApp::GLpYUEpetraDataPool::gete | ( | ) |
Definition at line 527 of file GLpApp_GLpYUEpetraDataPool.cpp.
double GLpApp::GLpYUEpetraDataPool::getbeta | ( | ) |
Definition at line 515 of file GLpApp_GLpYUEpetraDataPool.cpp.
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.
|
private |
Definition at line 142 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Coordinates of nodes that are unique to this subdomain.
Definition at line 145 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Global nodes (interior, nonoverlapping) in this subdomain.
Definition at line 147 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Coordinates of all nodes in this subdomain.
Definition at line 149 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Global nodes (interior + shared, overlapping) in this subdomain.
Definition at line 151 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Elements (this includes all overlapping nodes).
Definition at line 153 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Edges.
Definition at line 155 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Volume stiffness matrix.
Definition at line 158 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Control/state mass matrix.
Definition at line 160 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Volume mass matrix.
Definition at line 162 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Edge mass matrix.
Definition at line 164 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Basis matrix for p_bar=B*p.
Definition at line 167 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Augmented system matrix: [ I Jac* ] [Jac 0 ].
Definition at line 173 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Jacobian of the nonlinear term.
Definition at line 176 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Right-hand side of the PDE.
Definition at line 179 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
The desired state.
Definition at line 181 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Definition at line 183 of file GLpApp_GLpYUEpetraDataPool.hpp.
|
private |
Regularization parameter.
Definition at line 186 of file GLpApp_GLpYUEpetraDataPool.hpp.