Report Typos and Errors    
Semi-Lagrangian Library
Modular library for kinetic and gyrokinetic simulations of plasmas in fusion energy devices.
Derived types and interfaces | Functions/Subroutines
sll_m_qn_2d_polar Module Reference

Derived types and interfaces

type  sll_t_qn_2d_polar
 

Functions/Subroutines

subroutine, public sll_s_qn_2d_polar_init (this, eta_min, eta_max, Nc, N_points, lambda, T_i)
 
subroutine, public sll_s_compute_splines_coefs_matrix_nat_1d (mat, dnat, lnat, N)
 
subroutine, public sll_s_compute_splines_coefs_matrix_per_1d (mat, dper, lper, mper, N)
 
subroutine kronecker_product (A, NxA, NyA, B, NxB, NyB, kronecker)
 
subroutine matrix_product (A, NxA, NyA, B, NxB, NyB, prod)
 
subroutine, public sll_s_matrix_product_compf (A, NxA, NyA, B, NxB, NyB, prod)
 
subroutine matrix_product_comp (A, NxA, NyA, B, NxB, NyB, prod)
 
subroutine matrix_product_circ (A, NxA, NyA, B, NxB, NyB, prod, Ntheta)
 
subroutine, public sll_s_precompute_gyroaverage_index (quasineutral, rho, N_rho)
 
subroutine, public sll_s_precompute_inverse_qn_matrix_polar_splines (quasineutral, mu_points, mu_weights, N_mu)
 
subroutine, public sll_s_qn_2d_polar_solve (quasineutral, phi)
 
subroutine, public sll_s_qn_2d_polar_test_solve (Nc, eta_min, eta_max, mu_points, mu_weights, N_mu, mode, lambda, T_i, phi_init, phi_qn)
 
real(kind=f64) function, public sll_f_compute_gamma0_quadrature (Nc, eta_min, eta_max, mu_points, mu_weights, N_mu, mode)
 
subroutine solve_circulant_system (Ntheta, Nr, mat_circ, sol)
 
subroutine test_solve_circulant_system (mat, Nr, Ntheta)
 
subroutine hermite_coef_nat_per (f, buf3d, N, d)
 
subroutine hermite_c1_coef_nat_per (f, buf3d, N, d)
 
subroutine compute_w_hermite (w, r, s)
 
subroutine, public sll_s_localize_polar (x, eta_min, eta_max, ii, eta, N)
 
subroutine localize_per (i, x, xmin, xmax, N)
 
subroutine localize_nat (i, x, xmin, xmax, N)
 
subroutine interpolate_hermite (f, i, x, fval, N)
 
subroutine interpolate_hermite_c1 (f, i, x, fval, N)
 
subroutine contribution_hermite_c1 (x, val)
 
subroutine, public sll_s_contribution_spl (x, val)
 
subroutine splcoefnat1d0 (lunat, N)
 
subroutine splcoefnat1d (p, lunat, N)
 
subroutine, public sll_s_splcoefnat1d0old (dnat, lnat, N)
 
subroutine splcoefnatper2d (f, buf, dnatx, lnatx, dpery, lpery, mpery, Nx, Ny)
 
subroutine splnatper2d (f, xx, xmin, xmax, yy, ymin, ymax, fval, Nx, Ny)
 
subroutine splper1d (f, xx, xmin, xmax, fval, N)
 
subroutine splnat1d (f, xx, xmin, xmax, fval, N)
 
subroutine, public sll_s_splcoefper1d0old (dper, lper, mper, N)
 
subroutine splcoefper1d0 (luper, N)
 
subroutine splcoefper1d (f, luper, N)
 
subroutine splcoefnat1dold (p, dnat, lnat, N)
 
subroutine splcoefper1dold (f, dper, lper, mper, N)
 
subroutine solve_tridiag (a, b, c, v, x, n)
 
subroutine compute_n_bounds_polar_circle (N_min, N_max, N, rho, eta_min, eta_max)
 
subroutine compute_factor_bounds (f, f_init, eps, bounds, N_min, N_max)
 
subroutine, public sll_s_compute_error (f, f_init, J_factor, err, N_min, N_max)
 
subroutine compute_error_1d (f, f_init, J_factor, err, N_min, N_max)
 
subroutine solution_polar_circle (rho, mode, eta_min, eta_max, val)
 
subroutine, public sll_s_compute_gamma0 (mode, eta_min, eta_max, val)
 
subroutine, public sll_s_mu_quadr_for_phi_init (quasineutral, mu_quadr_for_phi_case, N_mu_for_phi, mu_max_for_phi, mu_points_user_defined, mu_weights_user_defined, N_mu_user_defined)
 

Function/Subroutine Documentation

◆ compute_error_1d()

subroutine sll_m_qn_2d_polar::compute_error_1d ( intent(in)  f,
intent(in)  f_init,
intent(in)  J_factor,
dimension(3), intent(out)  err,
dimension(2), intent(in)  N_min,
dimension(2), intent(in)  N_max 
)
private

Definition at line 1699 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ compute_factor_bounds()

subroutine sll_m_qn_2d_polar::compute_factor_bounds ( intent(in)  f,
intent(in)  f_init,
intent(in)  eps,
dimension(2), intent(out)  bounds,
dimension(2), intent(in)  N_min,
dimension(2), intent(in)  N_max 
)
private

Definition at line 1654 of file sll_m_qn_2d_polar.F90.

◆ compute_n_bounds_polar_circle()

subroutine sll_m_qn_2d_polar::compute_n_bounds_polar_circle ( intent(out)  N_min,
intent(out)  N_max,
intent(in)  N,
dimension(2), intent(in)  rho,
intent(in)  eta_min,
intent(in)  eta_max 
)
private

Definition at line 1635 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ compute_w_hermite()

subroutine sll_m_qn_2d_polar::compute_w_hermite ( real(kind=f64), dimension(r:s), intent(out)  w,
integer(kind=i32), intent(in)  r,
integer(kind=i32), intent(in)  s 
)
private

Definition at line 1024 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ contribution_hermite_c1()

subroutine sll_m_qn_2d_polar::contribution_hermite_c1 ( real(kind=f64), dimension(0:1), intent(in)  x,
real(kind=f64), dimension(4, 0:1, 0:1), intent(out)  val 
)
private

Definition at line 1245 of file sll_m_qn_2d_polar.F90.

◆ hermite_c1_coef_nat_per()

subroutine sll_m_qn_2d_polar::hermite_c1_coef_nat_per ( real(kind=f64), dimension(n(1) + 1, n(2)), intent(in)  f,
real(kind=f64), dimension(4, n(1) + 1, n(2) + 1), intent(out)  buf3d,
integer, dimension(2), intent(in)  N,
integer, dimension(2), intent(in)  d 
)
private

Definition at line 961 of file sll_m_qn_2d_polar.F90.

Here is the call graph for this function:

◆ hermite_coef_nat_per()

subroutine sll_m_qn_2d_polar::hermite_coef_nat_per ( real(kind=f64), dimension(n(1) + 1, n(2)), intent(in)  f,
real(kind=f64), dimension(9, n(1) + 1, n(2) + 1), intent(out)  buf3d,
integer(kind=i32), dimension(2), intent(in)  N,
integer(kind=i32), dimension(2), intent(in)  d 
)
private

Definition at line 864 of file sll_m_qn_2d_polar.F90.

Here is the call graph for this function:

◆ interpolate_hermite()

subroutine sll_m_qn_2d_polar::interpolate_hermite ( real(kind=f64), dimension(0:8, 0:n(1), 0:n(2))  f,
integer(kind=i32), dimension(2), intent(in)  i,
real(kind=f64), dimension(2), intent(in)  x,
real(kind=f64), intent(out)  fval,
integer(kind=i32), dimension(2), intent(in)  N 
)
private

Definition at line 1148 of file sll_m_qn_2d_polar.F90.

◆ interpolate_hermite_c1()

subroutine sll_m_qn_2d_polar::interpolate_hermite_c1 ( real(kind=f64), dimension(0:3, 0:n(1), 0:n(2))  f,
integer(kind=i32), dimension(2), intent(in)  i,
real(kind=f64), dimension(2), intent(in)  x,
real(kind=f64), intent(out)  fval,
integer(kind=i32), dimension(2), intent(in)  N 
)
private

Definition at line 1197 of file sll_m_qn_2d_polar.F90.

◆ kronecker_product()

subroutine sll_m_qn_2d_polar::kronecker_product ( real(kind=f64), dimension(0:nxa - 1, 0:nya - 1), intent(in)  A,
integer(kind=i32), intent(in)  NxA,
integer(kind=i32), intent(in)  NyA,
real(kind=f64), dimension(0:nxb - 1, 0:nyb - 1), intent(in)  B,
integer(kind=i32), intent(in)  NxB,
integer(kind=i32), intent(in)  NyB,
real(kind=f64), dimension(0:nxa*nxb - 1, 0:nya*nyb - 1), intent(inout)  kronecker 
)
private

Definition at line 212 of file sll_m_qn_2d_polar.F90.

◆ localize_nat()

subroutine sll_m_qn_2d_polar::localize_nat ( integer(kind=i32), intent(out)  i,
real(kind=f64), intent(inout)  x,
real(kind=f64), intent(in)  xmin,
real(kind=f64), intent(in)  xmax,
integer(kind=i32), intent(in)  N 
)
private

Definition at line 1127 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ localize_per()

subroutine sll_m_qn_2d_polar::localize_per ( integer(kind=i32), intent(out)  i,
real(kind=f64), intent(inout)  x,
real(kind=f64), intent(in)  xmin,
real(kind=f64), intent(in)  xmax,
integer(kind=i32), intent(in)  N 
)
private

Definition at line 1111 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ matrix_product()

subroutine sll_m_qn_2d_polar::matrix_product ( real(kind=f64), dimension(0:nxa - 1, 0:nya - 1), intent(in)  A,
integer(kind=i32), intent(in)  NxA,
integer(kind=i32), intent(in)  NyA,
real(kind=f64), dimension(0:nxb - 1, 0:nyb - 1), intent(in)  B,
integer(kind=i32), intent(in)  NxB,
integer(kind=i32), intent(in)  NyB,
real(kind=f64), dimension(0:nxa - 1, 0:nyb - 1), intent(inout)  prod 
)
private

Definition at line 231 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ matrix_product_circ()

subroutine sll_m_qn_2d_polar::matrix_product_circ ( real(kind=f64), dimension(0:ntheta - 1, 0:nxa - 1, 0:nya - 1), intent(in)  A,
integer(kind=i32), intent(in)  NxA,
integer(kind=i32), intent(in)  NyA,
real(kind=f64), dimension(0:ntheta - 1, 0:nxb - 1, 0:nyb - 1), intent(in)  B,
integer(kind=i32), intent(in)  NxB,
integer(kind=i32), intent(in)  NyB,
real(kind=f64), dimension(0:ntheta - 1, 0:nxa - 1, 0:nyb - 1), intent(inout)  prod,
integer(kind=i32), intent(in)  Ntheta 
)
private

Definition at line 306 of file sll_m_qn_2d_polar.F90.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ matrix_product_comp()

subroutine sll_m_qn_2d_polar::matrix_product_comp ( complex(kind=f64), dimension(0:nxa - 1, 0:nya - 1), intent(in)  A,
integer(kind=i32), intent(in)  NxA,
integer(kind=i32), intent(in)  NyA,
complex(kind=f64), dimension(0:nxb - 1, 0:nyb - 1), intent(in)  B,
integer(kind=i32), intent(in)  NxB,
integer(kind=i32), intent(in)  NyB,
complex(kind=f64), dimension(0:nxa - 1, 0:nyb - 1), intent(inout)  prod 
)
private

Definition at line 281 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ sll_f_compute_gamma0_quadrature()

real(kind=f64) function, public sll_m_qn_2d_polar::sll_f_compute_gamma0_quadrature ( integer(kind=i32), dimension(2), intent(in)  Nc,
real(kind=f64), dimension(2), intent(in)  eta_min,
real(kind=f64), dimension(2), intent(in)  eta_max,
real(kind=f64), dimension(1:n_mu), intent(in)  mu_points,
real(kind=f64), dimension(1:n_mu), intent(in)  mu_weights,
integer(kind=i32), intent(in)  N_mu,
integer(kind=i32), dimension(2), intent(in)  mode 
)

Definition at line 710 of file sll_m_qn_2d_polar.F90.

Here is the call graph for this function:

◆ sll_s_compute_error()

subroutine, public sll_m_qn_2d_polar::sll_s_compute_error ( intent(in)  f,
intent(in)  f_init,
intent(in)  J_factor,
dimension(3), intent(out)  err,
dimension(2), intent(in)  N_min,
dimension(2), intent(in)  N_max 
)

Definition at line 1675 of file sll_m_qn_2d_polar.F90.

◆ sll_s_compute_gamma0()

subroutine, public sll_m_qn_2d_polar::sll_s_compute_gamma0 ( dimension(2), intent(in)  mode,
dimension(2), intent(in)  eta_min,
dimension(2), intent(in)  eta_max,
intent(out)  val 
)

Definition at line 1741 of file sll_m_qn_2d_polar.F90.

◆ sll_s_compute_splines_coefs_matrix_nat_1d()

subroutine, public sll_m_qn_2d_polar::sll_s_compute_splines_coefs_matrix_nat_1d ( real(kind=f64), dimension(0:n + 2, 1:n + 1), intent(inout)  mat,
real(kind=f64), dimension(0:n + 2), intent(in)  dnat,
real(kind=f64), dimension(0:n + 2), intent(in)  lnat,
integer(kind=i32), intent(in)  N 
)

Definition at line 123 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ sll_s_compute_splines_coefs_matrix_per_1d()

subroutine, public sll_m_qn_2d_polar::sll_s_compute_splines_coefs_matrix_per_1d ( real(kind=f64), dimension(0:n - 1, 0:n - 1), intent(inout)  mat,
real(kind=f64), dimension(0:n + 2), intent(in)  dper,
real(kind=f64), dimension(0:n + 2), intent(in)  lper,
real(kind=f64), dimension(0:n + 2), intent(in)  mper,
integer(kind=i32), intent(in)  N 
)

Definition at line 168 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ sll_s_contribution_spl()

subroutine, public sll_m_qn_2d_polar::sll_s_contribution_spl ( real(kind=f64), dimension(0:1), intent(in)  x,
real(kind=f64), dimension(-1:2, -1:2), intent(out)  val 
)

Definition at line 1282 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ sll_s_localize_polar()

subroutine, public sll_m_qn_2d_polar::sll_s_localize_polar ( real(kind=f64), dimension(2), intent(in)  x,
real(kind=f64), dimension(2), intent(in)  eta_min,
real(kind=f64), dimension(2), intent(in)  eta_max,
integer(kind=i32), dimension(2), intent(out)  ii,
real(kind=f64), dimension(2), intent(out)  eta,
integer(kind=i32), dimension(2), intent(in)  N 
)

Definition at line 1099 of file sll_m_qn_2d_polar.F90.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ sll_s_matrix_product_compf()

subroutine, public sll_m_qn_2d_polar::sll_s_matrix_product_compf ( complex(kind=f64), dimension(:, :), intent(in)  A,
integer(kind=i32), intent(in)  NxA,
integer(kind=i32), intent(in)  NyA,
complex(kind=f64), dimension(:, :), intent(in)  B,
integer(kind=i32), intent(in)  NxB,
integer(kind=i32), intent(in)  NyB,
complex(kind=f64), dimension(:, :), intent(inout)  prod 
)

Definition at line 256 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ sll_s_mu_quadr_for_phi_init()

subroutine, public sll_m_qn_2d_polar::sll_s_mu_quadr_for_phi_init ( type(sll_t_qn_2d_polar quasineutral,
character(len=256), intent(in)  mu_quadr_for_phi_case,
intent(in)  N_mu_for_phi,
intent(in)  mu_max_for_phi,
optional  mu_points_user_defined,
optional  mu_weights_user_defined,
intent(in)  N_mu_user_defined 
)

Definition at line 1777 of file sll_m_qn_2d_polar.F90.

◆ sll_s_precompute_gyroaverage_index()

subroutine, public sll_m_qn_2d_polar::sll_s_precompute_gyroaverage_index ( type(sll_t_qn_2d_polar quasineutral,
real(kind=f64), dimension(1:n_rho), intent(in)  rho,
integer(kind=i32)  N_rho 
)

Definition at line 334 of file sll_m_qn_2d_polar.F90.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ sll_s_precompute_inverse_qn_matrix_polar_splines()

subroutine, public sll_m_qn_2d_polar::sll_s_precompute_inverse_qn_matrix_polar_splines ( type(sll_t_qn_2d_polar quasineutral,
real(kind=f64), dimension(1:n_mu), intent(in)  mu_points,
real(kind=f64), dimension(1:n_mu), intent(in)  mu_weights,
integer(kind=i32), intent(in)  N_mu 
)

Definition at line 434 of file sll_m_qn_2d_polar.F90.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ sll_s_qn_2d_polar_init()

subroutine, public sll_m_qn_2d_polar::sll_s_qn_2d_polar_init ( type(sll_t_qn_2d_polar this,
real(kind=f64), dimension(2), intent(in)  eta_min,
real(kind=f64), dimension(2), intent(in)  eta_max,
integer(kind=i32), dimension(2), intent(in)  Nc,
integer(kind=i32), intent(in)  N_points,
real(kind=f64), dimension(:), intent(in)  lambda,
real(kind=f64), dimension(:), intent(in)  T_i 
)

Definition at line 95 of file sll_m_qn_2d_polar.F90.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ sll_s_qn_2d_polar_solve()

subroutine, public sll_m_qn_2d_polar::sll_s_qn_2d_polar_solve ( type(sll_t_qn_2d_polar quasineutral,
real(kind=f64), dimension(1:quasineutral%nc(1) + 1, 1:quasineutral%nc(2)), intent(inout)  phi 
)

Definition at line 583 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ sll_s_qn_2d_polar_test_solve()

subroutine, public sll_m_qn_2d_polar::sll_s_qn_2d_polar_test_solve ( integer(kind=i32), dimension(2), intent(in)  Nc,
real(kind=f64), dimension(2), intent(in)  eta_min,
real(kind=f64), dimension(2), intent(in)  eta_max,
real(kind=f64), dimension(1:n_mu), intent(in)  mu_points,
real(kind=f64), dimension(1:n_mu), intent(in)  mu_weights,
integer(kind=i32), intent(in)  N_mu,
integer(kind=i32), dimension(2), intent(in)  mode,
real(kind=f64), dimension(1:nc(1) + 1), intent(in)  lambda,
real(kind=f64), dimension(1:nc(1) + 1), intent(in)  T_i,
real(kind=f64), dimension(1:nc(1) + 1, 1:nc(2) + 1), intent(in)  phi_init,
real(kind=f64), dimension(1:nc(1) + 1, 1:nc(2) + 1), intent(in)  phi_qn 
)

Definition at line 645 of file sll_m_qn_2d_polar.F90.

Here is the call graph for this function:

◆ sll_s_splcoefnat1d0old()

subroutine, public sll_m_qn_2d_polar::sll_s_splcoefnat1d0old ( real(kind=f64), dimension(0:n + 2), intent(inout)  dnat,
real(kind=f64), dimension(0:n + 2), intent(inout)  lnat,
integer(kind=i32), intent(in)  N 
)

Definition at line 1360 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ sll_s_splcoefper1d0old()

subroutine, public sll_m_qn_2d_polar::sll_s_splcoefper1d0old ( real(kind=f64), dimension(0:n - 1), intent(out)  dper,
real(kind=f64), dimension(0:n - 1), intent(out)  lper,
real(kind=f64), dimension(0:n - 1), intent(out)  mper,
integer(kind=i32), intent(in)  N 
)

Definition at line 1502 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ solution_polar_circle()

subroutine sll_m_qn_2d_polar::solution_polar_circle ( dimension(2), intent(in)  rho,
dimension(2), intent(in)  mode,
dimension(2), intent(in)  eta_min,
dimension(2), intent(in)  eta_max,
intent(out)  val 
)
private

Definition at line 1723 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ solve_circulant_system()

subroutine sll_m_qn_2d_polar::solve_circulant_system ( integer(kind=i32)  Ntheta,
integer(kind=i32)  Nr,
real(kind=f64), dimension(0:ntheta - 1, 0:nr, 0:nr), intent(in)  mat_circ,
real(kind=f64), dimension(1:nr + 1, 1:ntheta), intent(inout)  sol 
)
private

Definition at line 748 of file sll_m_qn_2d_polar.F90.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ solve_tridiag()

subroutine sll_m_qn_2d_polar::solve_tridiag ( intent(in)  a,
intent(in)  b,
intent(in)  c,
intent(in)  v,
intent(out)  x,
intent(in)  n 
)
private

Definition at line 1599 of file sll_m_qn_2d_polar.F90.

◆ splcoefnat1d()

subroutine sll_m_qn_2d_polar::splcoefnat1d ( real(kind=f64), dimension(0:n + 2), intent(inout)  p,
real(kind=f64), dimension(0:1, 0:n + 2), intent(in)  lunat,
integer(kind=i32), intent(in)  N 
)
private

Definition at line 1337 of file sll_m_qn_2d_polar.F90.

◆ splcoefnat1d0()

subroutine sll_m_qn_2d_polar::splcoefnat1d0 ( real(kind=f64), dimension(0:1, 0:n + 2), intent(out)  lunat,
integer(kind=i32), intent(in)  N 
)
private

Definition at line 1317 of file sll_m_qn_2d_polar.F90.

◆ splcoefnat1dold()

subroutine sll_m_qn_2d_polar::splcoefnat1dold ( real(kind=f64), dimension(0:n + 2), intent(inout)  p,
real(kind=f64), dimension(0:n + 2), intent(in)  dnat,
real(kind=f64), dimension(0:n + 2), intent(in)  lnat,
integer(kind=i32), intent(in)  N 
)
private

Definition at line 1557 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ splcoefnatper2d()

subroutine sll_m_qn_2d_polar::splcoefnatper2d ( real(kind=f64), dimension(:, :), pointer  f,
real(kind=f64), dimension(:), pointer  buf,
real(kind=f64), dimension(:), pointer  dnatx,
real(kind=f64), dimension(:), pointer  lnatx,
real(kind=f64), dimension(:), pointer  dpery,
real(kind=f64), dimension(:), pointer  lpery,
real(kind=f64), dimension(:), pointer  mpery,
integer(kind=i32), intent(in)  Nx,
integer(kind=i32), intent(in)  Ny 
)
private

Definition at line 1380 of file sll_m_qn_2d_polar.F90.

Here is the call graph for this function:

◆ splcoefper1d()

subroutine sll_m_qn_2d_polar::splcoefper1d ( real(kind=f64), dimension(0:n - 1), intent(inout)  f,
real(kind=f64), dimension(0:3*n - 1), intent(in)  luper,
integer(kind=i32), intent(in)  N 
)
private

Definition at line 1538 of file sll_m_qn_2d_polar.F90.

◆ splcoefper1d0()

subroutine sll_m_qn_2d_polar::splcoefper1d0 ( real(kind=f64), dimension(0:3*n - 1), intent(out)  luper,
integer(kind=i32), intent(in)  N 
)
private

Definition at line 1520 of file sll_m_qn_2d_polar.F90.

◆ splcoefper1dold()

subroutine sll_m_qn_2d_polar::splcoefper1dold ( real(kind=f64), dimension(0:n - 1), intent(inout)  f,
real(kind=f64), dimension(0:n - 1), intent(in)  dper,
real(kind=f64), dimension(0:n - 1), intent(in)  lper,
real(kind=f64), dimension(0:n - 1), intent(in)  mper,
integer(kind=i32), intent(in)  N 
)
private

Definition at line 1580 of file sll_m_qn_2d_polar.F90.

Here is the caller graph for this function:

◆ splnat1d()

subroutine sll_m_qn_2d_polar::splnat1d ( real(kind=f64), dimension(0:n + 2), intent(inout)  f,
real(kind=f64), intent(in)  xx,
real(kind=f64), intent(in)  xmin,
real(kind=f64), intent(in)  xmax,
real(kind=f64), intent(out)  fval,
integer(kind=i32), intent(in)  N 
)
private

Definition at line 1478 of file sll_m_qn_2d_polar.F90.

◆ splnatper2d()

subroutine sll_m_qn_2d_polar::splnatper2d ( real(kind=f64), dimension(:, :), pointer  f,
real(kind=f64), intent(in)  xx,
real(kind=f64), intent(in)  xmin,
real(kind=f64), intent(in)  xmax,
real(kind=f64), intent(in)  yy,
real(kind=f64), intent(in)  ymin,
real(kind=f64), intent(in)  ymax,
real(kind=f64), intent(out)  fval,
integer(kind=i32), intent(in)  Nx,
integer(kind=i32), intent(in)  Ny 
)
private

Definition at line 1400 of file sll_m_qn_2d_polar.F90.

◆ splper1d()

subroutine sll_m_qn_2d_polar::splper1d ( real(kind=f64), dimension(0:n - 1), intent(inout)  f,
real(kind=f64), intent(in)  xx,
real(kind=f64), intent(in)  xmin,
real(kind=f64), intent(in)  xmax,
real(kind=f64), intent(out)  fval,
integer(kind=i32), intent(in)  N 
)
private

Definition at line 1457 of file sll_m_qn_2d_polar.F90.

◆ test_solve_circulant_system()

subroutine sll_m_qn_2d_polar::test_solve_circulant_system ( real(kind=f64), dimension(0:ntheta - 1, 0:nr, 0:nr), intent(in)  mat,
integer(kind=i32), intent(in)  Nr,
integer(kind=i32), intent(in)  Ntheta 
)
private

Definition at line 828 of file sll_m_qn_2d_polar.F90.

Here is the call graph for this function:
    Report Typos and Errors