Example solution of a Poisson equation on a hexahedral mesh using nodal (Hgrad) elements.
More...
|
int | TestMultiLevelPreconditionerLaplace (char ProblemType[], Teuchos::ParameterList &MLList, Epetra_CrsMatrix &A, const Epetra_MultiVector &xexact, Epetra_MultiVector &b, Epetra_MultiVector &uh, double &TotalErrorResidual, double &TotalErrorExactSol) |
| ML Preconditioner. More...
|
|
template<typename Scalar > |
const Scalar | exactSolution (const Scalar &x, const Scalar &y, const Scalar &z) |
| User-defined exact solution. More...
|
|
template<typename Scalar > |
void | materialTensor (Scalar material[][3], const Scalar &x, const Scalar &y, const Scalar &z) |
| User-defined material tensor. More...
|
|
template<typename Scalar > |
void | exactSolutionGrad (Scalar gradExact[3], const Scalar &x, const Scalar &y, const Scalar &z) |
| Computes gradient of the exact solution. Requires user-defined exact solution. More...
|
|
template<typename Scalar > |
const Scalar | sourceTerm (Scalar &x, Scalar &y, Scalar &z) |
| Computes source term: f = -div(A.grad u). Requires user-defined exact solution and material tensor. More...
|
|
template<class ArrayOut , class ArrayIn > |
void | evaluateMaterialTensor (ArrayOut &worksetMaterialValues, const ArrayIn &evaluationPoints) |
| Computation of the material tensor at array of points in physical space. More...
|
|
template<class ArrayOut , class ArrayIn > |
void | evaluateSourceTerm (ArrayOut &sourceTermValues, const ArrayIn &evaluationPoints) |
| Computation of the source term at array of points in physical space. More...
|
|
template<class ArrayOut , class ArrayIn > |
void | evaluateExactSolution (ArrayOut &exactSolutionValues, const ArrayIn &evaluationPoints) |
| Computation of the exact solution at array of points in physical space. More...
|
|
template<class ArrayOut , class ArrayIn > |
void | evaluateExactSolutionGrad (ArrayOut &exactSolutionGradValues, const ArrayIn &evaluationPoints) |
| Computation of the gradient of the exact solution at array of points in physical space. More...
|
|
int | main (int argc, char *argv[]) |
|
Example solution of a Poisson equation on a hexahedral mesh using nodal (Hgrad) elements.
Example solution of a Poisson equation on a quad mesh using nodal (Hgrad) elements.
This example uses the following Trilinos packages:
- Pamgen to generate a Hexahedral mesh.
- Sacado to form the source term from user-specified manufactured solution.
- Intrepid to build the discretization matrix and right-hand side.
- Epetra to handle the global matrix and vector.
- Isorropia to partition the matrix. (Optional)
- ML to solve the linear system.
Poisson system:
div A grad u = f in Omega
u = g on Gamma
where
A is a symmetric, positive definite material tensor
f is a given source term
Corresponding discrete linear system for nodal coefficients(x):
Kx = b
K - HGrad stiffness matrix
b - right hand side vector
- Author
- Created by P. Bochev, D. Ridzal, K. Peterson, D. Hensinger, C. Siefert.
This example uses the following Trilinos packages:
- Pamgen to generate a Quad mesh.
- Sacado to form the source term from user-specified manufactured solution.
- Intrepid to build the discretization matrix and right-hand side.
- Epetra to handle the global matrix and vector.
- Isorropia to partition the matrix. (Optional)
- ML to solve the linear system.
Poisson system:
div A grad u = f in Omega
u = g on Gamma
where
A is a symmetric, positive definite material tensor
f is a given source term
Corresponding discrete linear system for nodal coefficients(x):
Kx = b
K - HGrad stiffness matrix
b - right hand side vector
- Author
- Created by P. Bochev, D. Ridzal, K. Peterson, D. Hensinger, C. Siefert.
This example uses the following Trilinos packages:
- Pamgen to generate a Quad mesh.
- Sacado to form the source term from user-specified manufactured solution.
- Intrepid to build the discretization matrix and right-hand side.
- Epetra to handle the global matrix and vector.
- Isorropia to partition the matrix. (Optional)
- ML to solve the linear system.
Poisson system:
div A grad u = f in Omega
u = g on Gamma
where
A is a symmetric, positive definite material tensor
f is a given source term
Corresponding discrete linear system for nodal coefficients(x):
Kx = b
K - HGrad stiffness matrix
b - right hand side vector
- Author
- Created by P. Bochev, D. Ridzal, K. Peterson, D. Hensinger, C. Siefert.
This example uses the following Trilinos packages:
- Pamgen to generate a Quad mesh.
- Sacado to form the source term from user-specified manufactured solution.
- Intrepid to build the discretization matrix and right-hand side.
- Tpetra to handle the global matrix and vector.
- Isorropia to partition the matrix. (Optional)
- MueLu to solve the linear system.
Poisson system:
div A grad u = f in Omega
u = g on Gamma
where
A is a symmetric, positive definite material tensor
f is a given source term
Corresponding discrete linear system for nodal coefficients(x):
Kx = b
K - HGrad stiffness matrix
b - right hand side vector
- Author
- Created by P. Bochev, D. Ridzal, K. Peterson, D. Hensinger, C. Siefert.
This example uses the following Trilinos packages:
- Pamgen to generate a Quad mesh.
- Sacado to form the source term from user-specified manufactured solution.
- Intrepid to build the discretization matrix and right-hand side.
- Tpetra to handle the global matrix and vector.
- Isorropia to partition the matrix. (Optional)
- ML to solve the linear system.
Poisson system:
div A grad u = f in Omega
u = g on Gamma
where
A is a symmetric, positive definite material tensor
f is a given source term
Corresponding discrete linear system for nodal coefficients(x):
Kx = b
K - HGrad stiffness matrix
b - right hand side vector
- Author
- Created by P. Bochev, D. Ridzal, K. Peterson, D. Hensinger, C. Siefert.
This example uses the following Trilinos packages:
- Pamgen to generate a Hexahedral mesh.
- Sacado to form the source term from user-specified manufactured solution.
- Intrepid to build the discretization matrix and right-hand side.
- Epetra to handle the global matrix and vector.
- Isorropia to partition the matrix. (Optional)
- ML to solve the linear system.
Poisson system:
div A grad u = f in Omega
u = g on Gamma
where
A is a symmetric, positive definite material tensor
f is a given source term
Corresponding discrete linear system for nodal coefficients(x):
Kx = b
K - HGrad stiffness matrix
b - right hand side vector
- Author
- Created by P. Bochev, D. Ridzal, K. Peterson, D. Hensinger, C. Siefert.