XGCa
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"
 

Functions/Subroutines

subroutine petsc_solve (nn, bb, bb2, xx, comm, solver, x_boundary, b_boundary, b2_boundary, bdy_flag, ierr)
 
subroutine petsc_spectral_solve (nn, solver, rhs1, rhs2, field, ierr)
 Driver for the spectral XGC field solver. More...
 

Macro Definition Documentation

◆ __FUNCT__

#define __FUNCT__   "petsc_solve"

Function/Subroutine Documentation

◆ petsc_solve()

subroutine petsc_solve ( integer  nn,
  bb,
  bb2,
  xx,
integer  comm,
type(xgc_solver solver,
dimension(solver%n_boundary)  x_boundary,
dimension(solver%n_boundary)  b_boundary,
dimension(solver%n_boundary)  b2_boundary,
logical, intent(in)  bdy_flag,
  ierr 
)
Here is the call graph for this function:
Here is the caller graph for this function:

◆ petsc_spectral_solve()

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: