XGC1
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Pages
Macros | Functions/Subroutines
petsc_solve.F90 File Reference
#include "petsc_version_defs.h"
#include <petsc/finclude/petscsnes.h>
#include <petscversion.h>
Include dependency graph for petsc_solve.F90:

Macros

#define __FUNCT__   "petsc_solve"
 
#define __FUNCT__   "FormJacobian"
 
#define __FUNCT__   "FormFunction"
 
#define __FUNCT__   "write_vec"
 

Functions/Subroutines

subroutine petsc_solve (nn, bb, bb2, xx, comm, solver, ierr)
 
subroutine formjacobian (dummy, X, jac, jac_prec, solver, ierr)
 
subroutine formfunction (snes_dummy, X, F, solver, ierr)
 
subroutine write_vec (nn, phi, file_name, vec_name, ierr)
 
subroutine petsc_spectral_solve (nn, solver, rhs1, rhs2, field, ierr)
 Driver for the spectral XGC field solver. More...
 

Macro Definition Documentation

#define __FUNCT__   "petsc_solve"
#define __FUNCT__   "FormJacobian"
#define __FUNCT__   "FormFunction"
#define __FUNCT__   "write_vec"

Function/Subroutine Documentation

subroutine formfunction (   snes_dummy,
  X,
  F,
type(xgc_solver)  solver,
  ierr 
)

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine formjacobian (   dummy,
  X,
  jac,
  jac_prec,
type(xgc_solver)  solver,
  ierr 
)

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine petsc_solve ( integer  nn,
  bb,
  bb2,
  xx,
integer  comm,
type(xgc_solver)  solver,
  ierr 
)

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine petsc_spectral_solve ( integer, intent(in)  nn,
type(xgc_solver), intent(inout)  solver,
real(kind=8), dimension(nn,solver%blocksize), intent(in)  rhs1,
real(kind=8), dimension(nn,solver%blocksize), intent(in)  rhs2,
real(kind=8), dimension(nn,solver%blocksize), intent(out)  field,
  ierr 
)

Driver for the spectral XGC field solver.

Parameters
[in]nnNumber of vertices per plane in XGC mesh, integer
[in]solverXGC solver object, type(xgc_solver)
[in]rhs1Main right hand side vector, real(8)
[in]rhs2Secondary right hand side vector, real(8)
[out]fieldSolution of the field equation, real(8)
[in,out]ierrPETSc error code, PetscErrorCode

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine write_vec ( integer, intent(in)  nn,
dimension(nn)  phi,
character (len=*), intent(in)  file_name,
character (len=*), intent(in)  vec_name,
intent(out)  ierr 
)