Procedures

ProcedureLocationProcedure TypeDescription
abs_diff_sk_ku test_algen Function
add_tang test_algen Function
adjmut pikaia_oop Subroutine

Dynamical adjustment of mutation rate:

Read more…
alloc_fftw3 fftw3 Subroutine

Allocation of the memory needed by the transformations, forward and backward. 1 FFT distributed on several threads

Read more…
alloc_fftw3_real fftw3 Subroutine

Allocation of the memory needed by the transformations, forward and backward, for the real case. 1 FFT distributed on several threads

Read more…
analyse_solver solver Subroutine

Subroutine to analyse, factorize (symbolic) the matrix of the system

apod fftw3 Subroutine

Function that returns an apodized array.

Read more…
autocov_impo test_least Function

Function that returns

Read more…
build_surf surfile Subroutine

Creates an object OBJ_SURF from an array

c_f_string surfile Subroutine

Converts a C string to a Fortran string

Read more…
c_umfpack_di_defaults mumfpack Interface
c_umfpack_di_free_numeric mumfpack Interface
c_umfpack_di_free_symbolic mumfpack Interface
c_umfpack_di_load_numeric mumfpack Interface
c_umfpack_di_load_symbolic mumfpack Interface
c_umfpack_di_numeric mumfpack Interface
c_umfpack_di_report_control mumfpack Interface
c_umfpack_di_report_info mumfpack Interface
c_umfpack_di_report_numeric mumfpack Interface
c_umfpack_di_report_status mumfpack Interface
c_umfpack_di_report_symbolic mumfpack Interface
c_umfpack_di_save_numeric mumfpack Interface
c_umfpack_di_save_symbolic mumfpack Interface
c_umfpack_di_scale mumfpack Interface
c_umfpack_di_solve mumfpack Interface
c_umfpack_di_symbolic mumfpack Interface
c_umfpack_zi_defaults mumfpack Interface
c_umfpack_zi_free_numeric mumfpack Interface
c_umfpack_zi_free_symbolic mumfpack Interface
c_umfpack_zi_load_numeric mumfpack Interface
c_umfpack_zi_load_symbolic mumfpack Interface
c_umfpack_zi_numeric mumfpack Interface
c_umfpack_zi_report_control mumfpack Interface
c_umfpack_zi_report_info mumfpack Interface
c_umfpack_zi_report_numeric mumfpack Interface
c_umfpack_zi_report_status mumfpack Interface
c_umfpack_zi_report_symbolic mumfpack Interface
c_umfpack_zi_save_numeric mumfpack Interface
c_umfpack_zi_save_symbolic mumfpack Interface
c_umfpack_zi_scale mumfpack Interface
c_umfpack_zi_solve mumfpack Interface
c_umfpack_zi_symbolic mumfpack Interface
calc_fftw3 fftw3 Subroutine

Subroutine that transforms forward or backward a double complex array. For speed reasons FFTW will always work on the same memory area, until the plans are destroyed of course. 1 FFT distributed on several threads

Read more…
calc_fftw3_real_bwd fftw3 Subroutine

Subroutine that transforms backward a double real array. For speed reasons FFTW will always work on the same memory area, until the plans are destroyed of course. 1 FFT distributed on several threads

Read more…
calc_fftw3_real_fwd fftw3 Subroutine

Subroutine that transforms forward a double real array. For speed reasons FFTW will always work on the same memory area, until the plans are destroyed of course. 1 FFT distributed on several threads

Read more…
calc_imp_acf test_least Subroutine

Function that returns the theoretical autocorrelation function in an array.
The autocorrelation function is supposed to be obtained from a real surface which must be periodic or nearly periodic (because of the use of FFTs). In addition, the surface is supposed to be 0 mean and normalized (), therefore acf is zero-mean and normalized so that its max value is 1.

Read more…
calc_Jf test_least Subroutine

Determine the Jacobian matrix of f

calc_moments_1D test_algen Subroutine
change_array_order sort_arrays Subroutine

Given an order vector, sort a real or integer vector

check_inputs bspline Subroutine

Check the validity of the inputs to the “ink” routines. Prints warning message if there is an error, and also sets iflag and status_ok.

Read more…
chkder minpack Subroutine

CHKDER checks the gradients of M functions of N variables.

chkder_f test_minpack Subroutine

CHKDER_F is a function/jacobian routine for use with CHKDER_TEST.

chkder_test test_minpack Subroutine

CHKDER_TEST tests CHKDER.

choldc cholesky Subroutine

Given a positive definite symmetric matrix a(1:n,1:n), with physical dimensions np, this routine constructs its Cholesky decomposition, A=L L^T. On input, only the upper triangle of a need to be given; it is not modified. The Cholesky factor L is returned in the lower triangle of a, except for its diagonal elements which are returned in p(1:n).

Read more…
cholsl cholesky Subroutine

Solves the set of linear equations A x = b, where A is a positive- definite symmetric matrix with physical dimensions np. A and P are are input as the output from choldc. Only the lower triangle of A is accessed. B(1:n) is inout as the right-hand side vector. The solution vector is returned in X(1:n). A, n, np, and P are not modified and can be left in place for successive calls with different right-hand sides B. B is not modified unless you identify B and X in the calling sequence, which is allowed.

Read more…
clean_scratch files Subroutine

Subroutine that removes all files with extension .scratch

close_solver solver Subroutine

Subroutine to close the solver

close_superlu sulu_wrapper Subroutine

Subroutine to close the SuperLU process, with memory release

coeff_poly_tcheby_xy_vers_poly_monome tchebychev Subroutine

Transformation d’une CL de produits de polynômes de Tchebychev en x et y en polynôme classique

coeff_tcheby_vers_monome tchebychev Subroutine

Transformation des coefficients de Tchebychev en coefficients de monômes

Read more…
coeff_tcheby_xy_vers_monome tchebychev Subroutine

Transformation du produit de Tchebychev en coefficients de monômes

convert_matrice_format solver Subroutine

Compressed Column Storage (CCS) is also called the Harwell-Boeing sparse matrix format.

Read more…
convert_to_poly test_tchebychev Subroutine

Génération d’une surface polynômiale pour vérification des procédures d’approximation

cost test_algen Subroutine
cost_func test_algen Function
cross pikaia_oop Subroutine

breeds two parent chromosomes into two offspring chromosomes. breeding occurs through crossover. If the crossover probability test yields true (crossover taking place), either one-point or two-point crossover is used, with equal probabilities.

Read more…
db1ink bspline Subroutine

Determines the parameters of a function that interpolates the one-dimensional gridded data The interpolating function and its derivatives may subsequently be evaluated by the function db1val.

Read more…
db1val bspline Subroutine

Evaluates the tensor product piecewise polynomial interpolant constructed by the routine db1ink or one of its derivatives at the point xval.

Read more…
db2ink bspline Subroutine

Determines the parameters of a function that interpolates the two-dimensional gridded data The interpolating function and its derivatives may subsequently be evaluated by the function db2val.

Read more…
db2val bspline Subroutine

Evaluates the tensor product piecewise polynomial interpolant constructed by the routine db2ink or one of its derivatives at the point (xval,yval).

Read more…
dbintk bspline Subroutine

dbintk produces the b-spline coefficients, bcoef, of the b-spline of order k with knots t(i), i=1,…,n+k, which takes on the value y(i) at x(i), i=1,…,n. the spline or any of its derivatives can be evaluated by calls to dbvalu.

Read more…
dbknot bspline Subroutine

dbknot chooses a knot sequence for interpolation of order k at the data points x(i), i=1,..,n. the n+k knots are placed in the array t. k knots are placed at each endpoint and not-a-knot end conditions are used. the remaining knots are placed at data points if n is even and between data points if n is odd. the rightmost knot is shifted slightly to the right to insure proper interpolation at x(n) (see page 350 of the reference).

Read more…
dbnfac bspline Subroutine

Returns in w the LU-factorization (without pivoting) of the banded matrix a of order nrow with (nbandl + 1 + nbandu) bands or diagonals in the work array w .

Read more…
dbnslv bspline Subroutine

Companion routine to dbnfac. it returns the solution x of the linear system a*x = b in place of b, given the lu-factorization for a in the work array w from dbnfac.

Read more…
dbspvn bspline Subroutine

Calculates the value of all (possibly) nonzero basis functions at x of order max(jhigh,(j+1)*(index-1)), where t(k) <= x <= t(n+1) and j=iwork is set inside the routine on the first call when index=1. ileft is such that t(ileft) <= x < t(ileft+1). a call to dintrv(t,n+1,x,ilo,ileft,mflag) produces the proper ileft. dbspvn calculates using the basic algorithm needed in dbspvd. if only basis functions are desired, setting jhigh=k and index=1 can be faster than calling dbspvd, but extra coding is required for derivatives (index=2) and dbspvd is set up for this purpose.

Read more…
dbtpcf bspline Subroutine

dbtpcf computes b-spline interpolation coefficients for nf sets of data stored in the columns of the array fcn. the b-spline coefficients are stored in the rows of bcoef however. each interpolation is based on the n abcissa stored in the array x, and the n+k knots stored in the array t. the order of each interpolation is k. the work array must be of length at least 2k(n+1).

Read more…
dbvalu bspline Function

Evaluates the b-representation (t,a,n,k) of a b-spline at x for the function value on ideriv=0 or any of its derivatives on ideriv=1,2,…,k-1. right limiting values (right derivatives) are returned except at the right end point x=t(n+1) where left limiting values are computed. the spline is defined on t(k) <= x <= t(n+1). dbvalu returns a fatal error message when x is outside of this interval.

Read more…
dCreate_CompCol_Matrix sulu_wrapper Interface
dCreate_Dense_Matrix sulu_wrapper Interface
decode pikaia_oop Subroutine

decode genotype into phenotype parameters ph(k) are x,y coordinates [ 0 < x,y < 1 ]

def_tab1D test_intpl Function
def_tab2D test_intpl Function
desalloc_fftw3 fftw3 Subroutine

When no more transformation is needed, the memory is released. 1 FFT distributed on several threads

Read more…
Destroy_CompCol_Matrix sulu_wrapper Interface
Destroy_Dense_Matrix sulu_wrapper Interface
destroy_plan_fftw3 fftw3 Subroutine

Plans are no more needed as no additional transformation will occur. 1 FFT distributed on several threads

Destroy_SuperMatrix_Store sulu_wrapper Interface
Destroy_SuperNode_Matrix sulu_wrapper Interface
df test_least Function

Kind of particular 2D autocorrelation function. Numerical derivatives.

dgssvx sulu_wrapper Interface
dintrv bspline Subroutine

Computes the largest integer ileft in 1 <= ileft <= lxt such that XT(ileft) <= x where XT(*) is a subdivision of the x interval. precisely,

Read more…
dir_separator files Function

Function that returns the system directory separator

dirname files Function

Subroutine that keeps only the directory from a file path

dogleg minpack Subroutine

DOGLEG finds the minimizing combination of Gauss-Newton and gradient steps.

empty surfile Subroutine

Just empties a string

encode pikaia_oop Subroutine

Encode phenotype parameters into integer genotype ph(k) are x,y coordinates [ 0 < x,y < 1 ]

end_fftw3 fftw3 Subroutine

FFTW3 is no more useful from here. 1 FFT distributed on several threads

enorm minpack Function

ENORM computes the Euclidean norm of a vector.

enorm2 minpack Function

ENORM2 computes the Euclidean norm of a vector.

extend fftw3 Subroutine

Function that extends an array for FFT processing.

Read more…
f test_least Function

Kind of particular 2D autocorrelation function

f_c_string surfile Subroutine

Converts a Fortran string to a C string

Read more…
fact_superlu sulu_wrapper Subroutine

Subroutine to factorize the system

Read more…
factorize_solver solver Subroutine

Subroutine to factorize the matrix of the system

fdjac1 minpack Subroutine

FDJAC1 estimates an N by N jacobian matrix using forward differences.

fdjac2 minpack Subroutine

FDJAC2 estimates an M by N jacobian matrix using forward differences.

fftw_alignment_of fftw3 Interface
fftw_alloc_complex fftw3 Interface
fftw_alloc_real fftw3 Interface
fftw_cleanup fftw3 Interface
fftw_cleanup_threads fftw3 Interface
fftw_cost fftw3 Interface
fftw_destroy_plan fftw3 Interface
fftw_estimate_cost fftw3 Interface
fftw_execute_dft fftw3 Interface
fftw_execute_dft_c2r fftw3 Interface
fftw_execute_dft_r2c fftw3 Interface
fftw_execute_r2r fftw3 Interface
fftw_execute_split_dft fftw3 Interface
fftw_execute_split_dft_c2r fftw3 Interface
fftw_execute_split_dft_r2c fftw3 Interface
fftw_export_wisdom fftw3 Interface
fftw_export_wisdom_to_file fftw3 Interface
fftw_export_wisdom_to_filename fftw3 Interface
fftw_export_wisdom_to_string fftw3 Interface
fftw_flops fftw3 Interface
fftw_forget_wisdom fftw3 Interface
fftw_fprint_plan fftw3 Interface
fftw_free fftw3 Interface
fftw_import_system_wisdom fftw3 Interface
fftw_import_wisdom fftw3 Interface
fftw_import_wisdom_from_file fftw3 Interface
fftw_import_wisdom_from_filename fftw3 Interface
fftw_import_wisdom_from_string fftw3 Interface
fftw_init_threads fftw3 Interface
fftw_make_planner_thread_safe fftw3 Interface
fftw_malloc fftw3 Interface
fftw_plan_dft fftw3 Interface
fftw_plan_dft_1d fftw3 Interface
fftw_plan_dft_2d fftw3 Interface
fftw_plan_dft_3d fftw3 Interface
fftw_plan_dft_c2r fftw3 Interface
fftw_plan_dft_c2r_1d fftw3 Interface
fftw_plan_dft_c2r_2d fftw3 Interface
fftw_plan_dft_c2r_3d fftw3 Interface
fftw_plan_dft_r2c fftw3 Interface
fftw_plan_dft_r2c_1d fftw3 Interface
fftw_plan_dft_r2c_2d fftw3 Interface
fftw_plan_dft_r2c_3d fftw3 Interface
fftw_plan_guru64_dft fftw3 Interface
fftw_plan_guru64_dft_c2r fftw3 Interface
fftw_plan_guru64_dft_r2c fftw3 Interface
fftw_plan_guru64_r2r fftw3 Interface
fftw_plan_guru64_split_dft fftw3 Interface
fftw_plan_guru64_split_dft_c2r fftw3 Interface
fftw_plan_guru64_split_dft_r2c fftw3 Interface
fftw_plan_guru_dft fftw3 Interface
fftw_plan_guru_dft_c2r fftw3 Interface
fftw_plan_guru_dft_r2c fftw3 Interface
fftw_plan_guru_r2r fftw3 Interface
fftw_plan_guru_split_dft fftw3 Interface
fftw_plan_guru_split_dft_c2r fftw3 Interface
fftw_plan_guru_split_dft_r2c fftw3 Interface
fftw_plan_many_dft fftw3 Interface
fftw_plan_many_dft_c2r fftw3 Interface
fftw_plan_many_dft_r2c fftw3 Interface
fftw_plan_many_r2r fftw3 Interface
fftw_plan_r2r fftw3 Interface
fftw_plan_r2r_1d fftw3 Interface
fftw_plan_r2r_2d fftw3 Interface
fftw_plan_r2r_3d fftw3 Interface
fftw_plan_with_nthreads fftw3 Interface
fftw_planner_nthreads fftw3 Interface
fftw_print_plan fftw3 Interface
fftw_set_timelimit fftw3 Interface
fftw_sprint_plan fftw3 Interface
fftwf_alignment_of fftw3 Interface
fftwf_alloc_complex fftw3 Interface
fftwf_alloc_real fftw3 Interface
fftwf_cleanup fftw3 Interface
fftwf_cleanup_threads fftw3 Interface
fftwf_cost fftw3 Interface
fftwf_destroy_plan fftw3 Interface
fftwf_estimate_cost fftw3 Interface
fftwf_execute_dft fftw3 Interface
fftwf_execute_dft_c2r fftw3 Interface
fftwf_execute_dft_r2c fftw3 Interface
fftwf_execute_r2r fftw3 Interface
fftwf_execute_split_dft fftw3 Interface
fftwf_execute_split_dft_c2r fftw3 Interface
fftwf_execute_split_dft_r2c fftw3 Interface
fftwf_export_wisdom fftw3 Interface
fftwf_export_wisdom_to_file fftw3 Interface
fftwf_export_wisdom_to_filename fftw3 Interface
fftwf_export_wisdom_to_string fftw3 Interface
fftwf_flops fftw3 Interface
fftwf_forget_wisdom fftw3 Interface
fftwf_fprint_plan fftw3 Interface
fftwf_free fftw3 Interface
fftwf_import_system_wisdom fftw3 Interface
fftwf_import_wisdom fftw3 Interface
fftwf_import_wisdom_from_file fftw3 Interface
fftwf_import_wisdom_from_filename fftw3 Interface
fftwf_import_wisdom_from_string fftw3 Interface
fftwf_init_threads fftw3 Interface
fftwf_make_planner_thread_safe fftw3 Interface
fftwf_malloc fftw3 Interface
fftwf_plan_dft fftw3 Interface
fftwf_plan_dft_1d fftw3 Interface
fftwf_plan_dft_2d fftw3 Interface
fftwf_plan_dft_3d fftw3 Interface
fftwf_plan_dft_c2r fftw3 Interface
fftwf_plan_dft_c2r_1d fftw3 Interface
fftwf_plan_dft_c2r_2d fftw3 Interface
fftwf_plan_dft_c2r_3d fftw3 Interface
fftwf_plan_dft_r2c fftw3 Interface
fftwf_plan_dft_r2c_1d fftw3 Interface
fftwf_plan_dft_r2c_2d fftw3 Interface
fftwf_plan_dft_r2c_3d fftw3 Interface
fftwf_plan_guru64_dft fftw3 Interface
fftwf_plan_guru64_dft_c2r fftw3 Interface
fftwf_plan_guru64_dft_r2c fftw3 Interface
fftwf_plan_guru64_r2r fftw3 Interface
fftwf_plan_guru64_split_dft fftw3 Interface
fftwf_plan_guru64_split_dft_c2r fftw3 Interface
fftwf_plan_guru64_split_dft_r2c fftw3 Interface
fftwf_plan_guru_dft fftw3 Interface
fftwf_plan_guru_dft_c2r fftw3 Interface
fftwf_plan_guru_dft_r2c fftw3 Interface
fftwf_plan_guru_r2r fftw3 Interface
fftwf_plan_guru_split_dft fftw3 Interface
fftwf_plan_guru_split_dft_c2r fftw3 Interface
fftwf_plan_guru_split_dft_r2c fftw3 Interface
fftwf_plan_many_dft fftw3 Interface
fftwf_plan_many_dft_c2r fftw3 Interface
fftwf_plan_many_dft_r2c fftw3 Interface
fftwf_plan_many_r2r fftw3 Interface
fftwf_plan_r2r fftw3 Interface
fftwf_plan_r2r_1d fftw3 Interface
fftwf_plan_r2r_2d fftw3 Interface
fftwf_plan_r2r_3d fftw3 Interface
fftwf_plan_with_nthreads fftw3 Interface
fftwf_planner_nthreads fftw3 Interface
fftwf_print_plan fftw3 Interface
fftwf_set_timelimit fftw3 Interface
fftwf_sprint_plan fftw3 Interface
filename files Function

Subroutine that keeps only the file from a path

free_superlu sulu_wrapper Subroutine

Subroutine that actually does nothing yet. Maybe, there will be extra memory that could be released here?

freefact_solver solver Subroutine

Subroutine to free the factors if applicable

from_elemental_to_assembled solver Subroutine

Subroutine to transform the elemental entries into assembled CC vectors

func test_bspline Function
func_wrapper pikaia_oop Subroutine

Wrapper for the user’s function that is used by the main pikaia routine The x input to this function comes from pikaia, and will be between [0,1].

genere_coeff_lagrange intpl Subroutine

subroutine generating coefficients for kth-order interpolation

genere_surf_poly test_tchebychev Subroutine

génère une surface

genrand64_int64 mt19937_64 Function

Generates a random number on [-2^63, 2^63-1]-interval

genrand64_real1 mt19937_64 Function

Generates a random number on [0,1]-real-interval

genrand64_real2 mt19937_64 Function

Generates a random number on [0,1)-real-interval

genrand64_real3 mt19937_64 Function

Generates a random number on (0,1)-real-interval

genrep pikaia_oop Subroutine

Full generational replacement: accumulate offspring into new population array

get_unit gnufor Subroutine

GET_UNIT returns a free FORTRAN unit number.

get_unit miscellaneous Subroutine

Provide for a free unit, from here John Burkardt website

hybrd minpack Subroutine

HYBRD seeks a zero of N nonlinear equations in N variables.

hybrd1 minpack Subroutine

HYBRD1 seeks a zero of N nonlinear equations in N variables.

hybrd1_f test_minpack Subroutine

HYBRD1_F is a function routine for use with HYBRD1_TEST.

hybrd1_test test_minpack Subroutine

HYBRD1_TEST tests HYBRD1.

hybrj minpack Subroutine

HYBRJ seeks a zero of N nonlinear equations in N variables.

hybrj1 minpack Subroutine

HYBRJ1 seeks a zero of N equations in N variables by Powell’s method.

hybrj1_f test_minpack Subroutine

HYBRJ1_F is a function/jacobian routine for use with HYBRJ1_TEST.

hybrj1_test test_minpack Subroutine

HYBRJ1_TEST tests HYBRJ1.

init_by_array64 mt19937_64 Subroutine

Initializes by an array with array-length init_key is the array for initializing keys

init_fftw3 fftw3 Subroutine

Subroutine to initialize the FFTW3 process 1 FFT distributed on several threads. Complex case.

init_fftw3_real fftw3 Subroutine

Subroutine to initialize the FFTW3 process 1 FFT distributed on several threads Real case.

init_genrand64 mt19937_64 Subroutine

Initializes me%mt(nn) with a seed

init_genrand64_i4 mt19937_64 Subroutine

Initializes me%mt(nn) with a seed

init_order sort_arrays Subroutine

Vector initialization: 1 … n

init_scal surfile Subroutine

OBJ_SURF initialization, every unit is m

init_solver solver Subroutine

Subroutine to initialize the matrices of the solver

init_superlu sulu_wrapper Subroutine Read more…
interp intpl Function

Interpolate evenly spaced points

interp1D intpl Subroutine

Interpolate evenly spaced points, taking into account the borders

interp2D intpl Subroutine

Interpolate 2D evenly spaced points, taking into account the borders

interp_surf test_bspline Subroutine
is_linux files Function

Function that returns true if the operating system is linux

least_squares_tcheby tchebychev Subroutine

Resulting polynomial surface, determined by linear least squares

list_dirs files Subroutine

Subroutine that returns a list of subdirectories

list_files files Subroutine

Subroutine that returns a list of files in a directory

lmder minpack Subroutine

LMDER minimizes M functions in N variables by the Levenberg-Marquardt method.

lmder1 minpack Subroutine

LMDER1 minimizes M functions in N variables by Levenberg-Marquardt method.

lmder1_2_f test_minpack Subroutine

LMDER1_2_F is a function/jacobian routine for use with LMDER1_2_TEST.

lmder1_2_test test_minpack Subroutine

LMDER1_2_TEST tests LMDER1.

lmder1_f test_minpack Subroutine

LMDER1_F is a function/jacobian routine for use with LMDER1_TEST.

lmder1_test test_minpack Subroutine

LMDER1_TEST tests LMDER1.

lmdif minpack Subroutine

LMDIF minimizes M functions in N variables by the Levenberg-Marquardt method.

lmdif1 minpack Subroutine

LMDIF1 minimizes M functions in N variables using Levenberg-Marquardt method.

lmdif1_2_f test_minpack Subroutine

LMDIF1_2_F is a function routine for use with LMDIF1_2_TEST.

lmdif1_2_test test_minpack Subroutine

LMDIF1_2_TEST tests LMDIF1.

lmdif1_f test_minpack Subroutine

LMDIF1_F is a function routine for use with LMDIF1_TEST.

lmdif1_test test_minpack Subroutine

LMDIF1_TEST tests LMDIF1.

lmpar minpack Subroutine

LMPAR computes a parameter for the Levenberg-Marquardt method.

lmstr minpack Subroutine

LMSTR minimizes M functions in N variables using Levenberg-Marquardt method.

lmstr1 minpack Subroutine

LMSTR1 minimizes M functions in N variables using Levenberg-Marquardt method.

lmstr1_2_f test_minpack Subroutine

LMSTR1_2_F is a function/jacobian routine for use with LMSTR1_2_TEST.

lmstr1_2_test test_minpack Subroutine

LMSTR1_2_TEST tests LMSTR1.

lmstr1_f test_minpack Subroutine

LMSTR1_F is a function/jacobian routine for use with LMSTR1_TEST.

lmstr1_test test_minpack Subroutine

LMSTR1_TEST tests LMSTR1.

lower surfile Function

Converts uppercase to lowercase, adapted from here

make_CSC_ci mumfpack Function
make_CSC_di mumfpack Function
make_CSC_zi mumfpack Function
make_CSR_ci mumfpack Function
make_CSR_di mumfpack Function
make_CSR_zi mumfpack Function
make_path files Subroutine

Subroutine that creates the folders of a file path

make_plan_fftw3 fftw3 Subroutine

Creates forward and backward plans. 1 FFT distributed on several threads

Read more…
make_plan_fftw3_real fftw3 Subroutine

Creates forward and backward plans. 1 FFT distributed on several threads

Read more…
make_Vec_zi mumfpack Function
melange test_algen Subroutine
mkdir files Subroutine

Subroutine that creates a directory

modify_a_elt test_solvers Subroutine

mMltiplication of the system coefficient by a random factor

moindres_carres least_squares Subroutine

Function that returns the parameters of a function that approximates a data set. The parameters determination is achieved by non linear least squares approximation.

Read more…
moindres_carres_lineaire least_squares Subroutine

Function that returns the parameters of a function that approximates a data set. The parameters determination is achieved by linear least squares approximation.

Read more…
mutate pikaia_oop Subroutine

Introduces random mutation in a genotype. Mutations occur at rate pmut at all gene loci.

Read more…
newpop pikaia_oop Subroutine

Replaces old population by new; recomputes fitnesses & ranks

Read more…
newton_raphson_downhill test_algen Subroutine
open_surffile surfile Subroutine

Subroutine that opens a .sur file and transfers it contents into an object OBJ_SURF

Read more…
operator(.umfpack.) mumfpack Interface
path2vec files Subroutine

Subroutine that creates a vector containing the folders of a file path

pCSC mumfpack Interface
pCSR mumfpack Interface
pi gnufor Function

PI returns the value of pi.

pikaia pikaia_oop Subroutine

Optimization (maximization) of user-supplied “fitness” function over n-dimensional parameter space x using a basic genetic algorithm method.

Read more…
prep_superlu sulu_wrapper Subroutine

Subroutine to prepare the SULU_ENV components

prod_a_x test_solvers Subroutine

, assembled CC format

prod_elemental_x test_solvers Subroutine

, elemental CC format

profil_theo_trie_1D test_algen Subroutine
progress_bar_terminal miscellaneous Subroutine

Print a progress bar on the terminal

pVec mumfpack Interface
qform minpack Subroutine

QFORM produces the explicit QR factorization of a matrix.

qform_test test_minpack Subroutine

QFORM_TEST tests QFORM.

qrfac minpack Subroutine

QRFAC computes a QR factorization using Householder transformations.

qrsolv minpack Subroutine

QRSOLV solves a rectangular linear system A*x=b in the least squares sense.

r1mpyq minpack Subroutine

R1MPYQ computes A*Q, where Q is the product of Householder transformations.

r1updt minpack Subroutine

R1UPDT re-triangularizes a matrix after a rank one update.

r8_uniform_01 minpack Function

R8_UNIFORM_01 returns a unit pseudorandom R8.

r8mat_print minpack Subroutine

R8MAT_PRINT prints an R8MAT.

r8mat_print_some minpack Subroutine

R8MAT_PRINT_SOME prints some of an R8MAT.

r8vec_print minpack Subroutine

R8VEC_PRINT prints an R8VEC.

read_surf test_fftw3 Subroutine

Subroutine that opens a surface file .dat

read_surf surfile Subroutine

Subroutine that opens a surface file .sur or .dat

Read more…
report pikaia_oop Subroutine

Write generation report to standard output

restrict intpl Function

Restrict evenly spaced points

restrict1D intpl Subroutine

Restrict evenly spaced points, taking into account the borders

restrict2D intpl Subroutine

Interpolate 2D evenly spaced points, taking into account the borders

rninit pikaia_oop Subroutine

Initialize the random number generator with the input seed value.

rnkpop pikaia_oop Subroutine

Ranks initial population. Calls external sort routine to produce key index and rank order of input array arrin (which is not altered).

rqsort pikaia_oop Subroutine

Return integer array p which indexes array a in increasing order. Array a is not disturbed. The Quicksort algorithm is used.

Read more…
run_gnuplot gnufor Subroutine

RUN_GNUPLOT runs GNUPLOT with a given command file.

rwupdt minpack Subroutine

RWUPDT computes the decomposition of triangular matrix augmented by one row.

s_umfpack_ci_numeric mumfpack Subroutine
s_umfpack_ci_scale mumfpack Subroutine
s_umfpack_ci_solve mumfpack Subroutine
s_umfpack_ci_symbolic mumfpack Subroutine
s_umfpack_defaults mumfpack Interface
s_umfpack_di_defaults mumfpack Interface
s_umfpack_di_free_numeric mumfpack Interface
s_umfpack_di_free_symbolic mumfpack Interface
s_umfpack_di_load_numeric mumfpack Subroutine
s_umfpack_di_load_symbolic mumfpack Subroutine
s_umfpack_di_numeric mumfpack Subroutine
s_umfpack_di_report_control mumfpack Interface
s_umfpack_di_report_info mumfpack Interface
s_umfpack_di_save_numeric mumfpack Subroutine
s_umfpack_di_save_symbolic mumfpack Subroutine
s_umfpack_di_scale mumfpack Subroutine
s_umfpack_di_solve mumfpack Subroutine
s_umfpack_di_symbolic mumfpack Subroutine
s_umfpack_free_numeric mumfpack Interface
s_umfpack_free_symbolic mumfpack Interface
s_umfpack_load_numeric mumfpack Subroutine
s_umfpack_load_symbolic mumfpack Subroutine
s_umfpack_numeric mumfpack Interface
s_umfpack_report_control mumfpack Interface
s_umfpack_report_info mumfpack Interface
s_umfpack_save_numeric mumfpack Subroutine
s_umfpack_save_symbolic mumfpack Subroutine
s_umfpack_scale mumfpack Interface
s_umfpack_solve mumfpack Interface
s_umfpack_symbolic mumfpack Interface
s_umfpack_zi_defaults mumfpack Interface
s_umfpack_zi_free_numeric mumfpack Interface
s_umfpack_zi_free_symbolic mumfpack Interface
s_umfpack_zi_load_numeric mumfpack Subroutine
s_umfpack_zi_load_symbolic mumfpack Subroutine
s_umfpack_zi_numeric mumfpack Subroutine
s_umfpack_zi_numeric mumfpack Interface
s_umfpack_zi_report_control mumfpack Interface
s_umfpack_zi_report_info mumfpack Interface
s_umfpack_zi_save_numeric mumfpack Subroutine
s_umfpack_zi_save_symbolic mumfpack Subroutine
s_umfpack_zi_scale mumfpack Subroutine
s_umfpack_zi_scale mumfpack Interface
s_umfpack_zi_solve mumfpack Subroutine
s_umfpack_zi_solve mumfpack Interface
s_umfpack_zi_symbolic mumfpack Subroutine
s_umfpack_zi_symbolic mumfpack Interface
save_surf test_fftw3 Subroutine

Subroutine that saves a surface file .dat

scal2surf surfile Subroutine

Transform a SCALE_SURF object into a OBJ_SURF object

select_parents pikaia_oop Subroutine

Selects two parents from the population, using roulette wheel algorithm with the relative fitnesses of the phenotypes as the “hit” probabilities.

Read more…
set_default_options sulu_wrapper Interface
set_inputs pikaia_oop Subroutine

Constructor for the pikaia_class. The routine must be called before the solve routine can be used.

Read more…
sk_ku test_algen Subroutine
solution_solver solver Subroutine

Subroutine to solve the system (sparse A)

solv_superlu sulu_wrapper Subroutine

Subroutine to solve the system

Read more…
solve_syst solver Subroutine

General hat subroutine that handles the resolution steps:

Read more…
solve_with_pikaia pikaia_oop Subroutine

Main pikaia wrapper used by the class.

sort_array2 sort_arrays Subroutine

Sort 1D arrays, real or integer, according the first one

sort_array_integer sort_arrays Subroutine

Sort a vector of integers

sort_array_integer_with_order sort_arrays Subroutine

Sort a vector of integers and store the order

sort_array_real sort_arrays Subroutine

Sort a vector of reals

sort_array_real_with_order sort_arrays Subroutine

Sort a vector of reals and store the order

StatFree sulu_wrapper Interface
StatInit sulu_wrapper Interface
StatPrint sulu_wrapper Interface
stdrep pikaia_oop Subroutine

Steady-state reproduction: insert offspring pair into population only if they are fit enough (replace-random if irep=2 or replace-worst if irep=3).

str_remove_chars files Function

Function that removes the characters of a string from another string

str_replace files Function

Function that replaces a string with another string

surf2scal surfile Subroutine

Transform a OBJ_SURF object into a SCALE_SURF object

tab_alloc_fftw3 fftw3 Subroutine

Allocation of the memory needed by the transformations, forward and backward. several FFT on single thread each

Read more…
tab_alloc_fftw3_real fftw3 Subroutine

Allocation of the memory needed by the transformations, forward and backward, for the real case. several FFT on single thread each

Read more…
tab_calc_fftw3 fftw3 Subroutine

Subroutine that transforms forward or bacward a double complex array. For speed reasons FFTW will always work on the same memory area, until the plans are destroyed of course. several FFT on single thread each

Read more…
tab_calc_fftw3_real_bwd fftw3 Subroutine

Subroutine that transforms backward a real array. For speed reasons FFTW will always work on the same memory area, until the plans are destroyed of course. several FFT on single thread each

Read more…
tab_calc_fftw3_real_fwd fftw3 Subroutine

Subroutine that transforms forward a real array. For speed reasons FFTW will always work on the same memory area, until the plans are destroyed of course. several FFT on single thread each

Read more…
tab_desalloc_fftw3 fftw3 Subroutine

When no more transformation is needed, the memory is released. several FFT on single thread each

Read more…
tab_destroy_plan_fftw3 fftw3 Subroutine

Plans are no more needed as no additional transformation will occur. several FFT on single thread each

tab_end_fftw3 fftw3 Subroutine

FFTW3 is no more useful from here. several FFT on single thread each

tab_end_fftw3_real fftw3 Subroutine

FFTW3 is no more useful from here. several FFT on single thread each

tab_init_fftw3 fftw3 Subroutine

Subroutine to initialize the FFTW3 process several FFT on single thread each Complex case.

tab_init_fftw3_real fftw3 Subroutine

Subroutine to initialize the FFTW3 process several FFT on single thread each Real case.

tab_Jf_tcheby tchebychev Subroutine

Tableau des dérivées par rapport aux coefficients de tab_tche

tab_make_plan_fftw3 fftw3 Subroutine

Creates forward and backward plans. several FFT on single thread each

Read more…
tab_make_plan_fftw3_real fftw3 Subroutine

Creates forward and backward plans. several FFT on single thread each

Read more…
tab_poly_tcheby tchebychev Subroutine

Surface définie par un produit de polynômes de Tchebychev en x et y

Read more…
tab_tcheby tchebychev Subroutine

Valeurs tabulées de polynômes de Tchebychev

Read more…
tang test_algen Function
tcheby tchebychev Function

Valeur en x du polynôme de Tchebichev de degré n

Read more…
test01 gnufor Subroutine

TEST01 demonstrates the plotting of Y(X) data.

test02 gnufor Subroutine

TEST02 demonstrates the plotting of a table of data.

test03 gnufor Subroutine

TEST03 plots parameter (X,Y,Z) data.

test04 gnufor Subroutine

TEST04 plots vector data.

test05 gnufor Subroutine

TEST05 plots Z(X,Y) grid data as a surface.

test06 gnufor Subroutine

TEST06 plots Z(X,Y) grid data as contours.

test_interp_pond test_intpl Subroutine

Test interpolation/weighting function for a particular order

timestamp minpack Subroutine

TIMESTAMP prints the current YMDHMS date as a time stamp.

timestamp gnufor Subroutine

TIMESTAMP prints the current YMDHMS date as a time stamp.

trans_center2corner miscellaneous Subroutine

Generic subroutine for real or complex arrays that shift the center to the corners

trans_center2corner_cmpl miscellaneous Subroutine

Subroutine to transform an array of complexes so that the center is in the corners

trans_center2corner_real miscellaneous Subroutine

Subroutine to transform an array of reals so that the center is in the corners

trans_corner2center miscellaneous Subroutine

Generic subroutine for real or complex arrays that shift the corners to the center

trans_corner2center_cmpl miscellaneous Subroutine

Function to transform an acf complex array so that the acf maximum is in the center

trans_corner2center_real miscellaneous Subroutine

Function to transform an acf real array so that the acf maximum is in the center

trans_surf_tab surfile Subroutine

Write the heights of an OBJ_SURF object into a 2D array

trans_surf_txt surfile Subroutine

Writes an OBJ_SURF object in a text file

Read more…
umf4cdef mumfpack Subroutine
umf4cfnum mumfpack Subroutine
umf4cfnum mumfpack Interface
umf4cfnum_ip mumfpack Subroutine
umf4cfsym mumfpack Subroutine
umf4cfsym mumfpack Interface
umf4cfsym_ip mumfpack Subroutine
umf4clnum mumfpack Subroutine
umf4clnum mumfpack Interface
umf4clnum_ip mumfpack Subroutine
umf4clsym mumfpack Subroutine
umf4clsym mumfpack Interface
umf4clsym_ip mumfpack Subroutine
umf4cnum mumfpack Subroutine
umf4cnum mumfpack Interface
umf4cnum_ip mumfpack Subroutine
umf4cpcon mumfpack Subroutine
umf4cpinf mumfpack Subroutine
umf4cscal mumfpack Subroutine
umf4cscal mumfpack Interface
umf4cscal_ip mumfpack Subroutine
umf4csnum mumfpack Subroutine
umf4csnum mumfpack Interface
umf4csnum_ip mumfpack Subroutine
umf4csol mumfpack Subroutine
umf4csol mumfpack Interface
umf4csol_ip mumfpack Subroutine
umf4csolr mumfpack Subroutine
umf4csolr mumfpack Interface
umf4csolr_ip mumfpack Subroutine
umf4cssym mumfpack Subroutine
umf4cssym mumfpack Interface
umf4cssym_ip mumfpack Subroutine
umf4csym mumfpack Subroutine
umf4csym mumfpack Interface
umf4csym_ip mumfpack Subroutine
umf4def mumfpack Subroutine
umf4fnum mumfpack Subroutine
umf4fnum mumfpack Interface
umf4fnum_ip mumfpack Subroutine
umf4fsym mumfpack Subroutine
umf4fsym mumfpack Interface
umf4fsym_ip mumfpack Subroutine
umf4lnum mumfpack Subroutine
umf4lnum mumfpack Interface
umf4lnum_ip mumfpack Subroutine
umf4lsym mumfpack Subroutine
umf4lsym mumfpack Interface
umf4lsym_ip mumfpack Subroutine
umf4num mumfpack Subroutine
umf4num mumfpack Interface
umf4num_ip mumfpack Subroutine
umf4pcon mumfpack Subroutine
umf4pinf mumfpack Subroutine
umf4scal mumfpack Subroutine
umf4scal mumfpack Interface
umf4scal_ip mumfpack Subroutine
umf4snum mumfpack Subroutine
umf4snum mumfpack Interface
umf4snum_ip mumfpack Subroutine
umf4sol mumfpack Subroutine
umf4sol mumfpack Interface
umf4sol_ip mumfpack Subroutine
umf4solr mumfpack Subroutine
umf4solr mumfpack Interface
umf4solr_ip mumfpack Subroutine
umf4ssym mumfpack Subroutine
umf4ssym mumfpack Interface
umf4ssym_ip mumfpack Subroutine
umf4sym mumfpack Subroutine
umf4sym mumfpack Interface
umf4sym_ip mumfpack Subroutine
umf4zdef mumfpack Subroutine
umf4zfnum mumfpack Subroutine
umf4zfnum mumfpack Interface
umf4zfnum_ip mumfpack Subroutine
umf4zfsym mumfpack Subroutine
umf4zfsym mumfpack Interface
umf4zfsym_ip mumfpack Subroutine
umf4zlnum mumfpack Subroutine
umf4zlnum mumfpack Interface
umf4zlnum_ip mumfpack Subroutine
umf4zlsym mumfpack Subroutine
umf4zlsym mumfpack Interface
umf4zlsym_ip mumfpack Subroutine
umf4znum mumfpack Subroutine
umf4znum mumfpack Interface
umf4znum_ip mumfpack Subroutine
umf4zpcon mumfpack Subroutine
umf4zpinf mumfpack Subroutine
umf4zscal mumfpack Subroutine
umf4zscal mumfpack Interface
umf4zscal_ip mumfpack Subroutine
umf4zsnum mumfpack Subroutine
umf4zsnum mumfpack Interface
umf4zsnum_ip mumfpack Subroutine
umf4zsol mumfpack Subroutine
umf4zsol mumfpack Interface
umf4zsol_ip mumfpack Subroutine
umf4zsolr mumfpack Subroutine
umf4zsolr mumfpack Interface
umf4zsolr_ip mumfpack Subroutine
umf4zssym mumfpack Subroutine
umf4zssym mumfpack Interface
umf4zssym_ip mumfpack Subroutine
umf4zsym mumfpack Subroutine
umf4zsym mumfpack Interface
umf4zsym_ip mumfpack Subroutine
umfpack_ci_numeric mumfpack Function
umfpack_ci_operator_CSC mumfpack Function
umfpack_ci_operator_CSR mumfpack Function
umfpack_ci_operator_pCSC mumfpack Function
umfpack_ci_operator_pCSR mumfpack Function
umfpack_ci_scale mumfpack Function
umfpack_ci_solve mumfpack Function
umfpack_ci_symbolic mumfpack Function
umfpack_defaults mumfpack Subroutine
umfpack_di_defaults mumfpack Subroutine
umfpack_di_free_numeric mumfpack Subroutine
umfpack_di_free_symbolic mumfpack Subroutine
umfpack_di_load_numeric mumfpack Function
umfpack_di_load_symbolic mumfpack Function
umfpack_di_numeric mumfpack Function
umfpack_di_operator_CSC mumfpack Function
umfpack_di_operator_CSR mumfpack Function
umfpack_di_operator_pCSC mumfpack Function
umfpack_di_operator_pCSR mumfpack Function
umfpack_di_report_control mumfpack Subroutine
umfpack_di_report_info mumfpack Subroutine
umfpack_di_save_numeric mumfpack Function
umfpack_di_save_symbolic mumfpack Function
umfpack_di_scale mumfpack Function
umfpack_di_solve mumfpack Function
umfpack_di_symbolic mumfpack Function
umfpack_free_numeric mumfpack Subroutine
umfpack_free_symbolic mumfpack Subroutine
umfpack_load_numeric mumfpack Function
umfpack_load_symbolic mumfpack Function
umfpack_numeric mumfpack Interface
umfpack_report_control mumfpack Subroutine
umfpack_report_info mumfpack Subroutine
umfpack_save_numeric mumfpack Function
umfpack_save_symbolic mumfpack Function
umfpack_scale_function mumfpack Interface
umfpack_solve mumfpack Interface
umfpack_symbolic mumfpack Interface
umfpack_zi_defaults mumfpack Subroutine
umfpack_zi_free_numeric mumfpack Subroutine
umfpack_zi_free_symbolic mumfpack Subroutine
umfpack_zi_load_numeric mumfpack Function
umfpack_zi_load_symbolic mumfpack Function
umfpack_zi_numeric mumfpack Function
umfpack_zi_numeric mumfpack Interface
umfpack_zi_operator_CSC mumfpack Function
umfpack_zi_operator_CSR mumfpack Function
umfpack_zi_operator_pCSC mumfpack Function
umfpack_zi_operator_pCSR mumfpack Function
umfpack_zi_report_control mumfpack Subroutine
umfpack_zi_report_info mumfpack Subroutine
umfpack_zi_save_numeric mumfpack Function
umfpack_zi_save_symbolic mumfpack Function
umfpack_zi_scale mumfpack Function
umfpack_zi_scale mumfpack Interface
umfpack_zi_solve mumfpack Function
umfpack_zi_solve mumfpack Interface
umfpack_zi_symbolic mumfpack Function
umfpack_zi_symbolic mumfpack Interface
unit2IUc surfile Function

Convert a C type unit string into value (m)

unit2IUf surfile Function

Convert a unit string into value (m)

urand pikaia_oop Function

Return the next pseudo-random deviate from a sequence which is uniformly distributed in the interval [0,1]

vec2path files Subroutine

Subroutine that creates a path from vector of folders

verif_solution test_solvers Subroutine

The product of the system matrix by the solution , is calculated, and compared to the right hand side . The calculated error is the absolute error in %.

Read more…
write_polar_data gnufor Subroutine
write_polar_plot gnufor Subroutine
write_surf surfile Subroutine

Writes a height array into a surface file .sur or .dat

write_surffile surfile Subroutine

Write an object OBJ_SURF in a file

write_vector_data gnufor Subroutine

WRITE_VECTOR_DATA writes vector data to a file, for plotting by GNUPLOT.

write_vector_plot gnufor Subroutine

WRITE_VECTOR_PLOT writes GNUPLOT commands to plot vectors.

write_xy2_data gnufor Subroutine
write_xy2_plot gnufor Subroutine
write_xy_data gnufor Subroutine

WRITE_XY_DATA writes X(1:N), Y(1:N) data to a file.

write_xy_plot gnufor Subroutine

WRITE_XY_PLOT writes GNUPLOT commands to plot X(1:N), Y(1:N) data.

write_xyy_data gnufor Subroutine

WRITE_XYY_DATA writes a table of data to a file, for plotting by GNUPLOT.

write_xyy_plots gnufor Subroutine

WRITE_XYY_PLOTS writes GNUPLOT commands to make multiple (X,Y) plots.

write_xyz_data gnufor Subroutine

WRITE_XYZ_DATA writes X(1:N), Y(1:N), Z(1:N) data to a file.

write_xyz_plot gnufor Subroutine

WRITE_XYZ_PLOT writes commands to plot parametric (X,Y,Z) data.

write_xyzgrid_contour gnufor Subroutine

WRITE_XYZGRID_CONTOUR writes commands to plot contours of Z(X,Y).

write_xyzgrid_data gnufor Subroutine

WRITE_XYZGRID_DATA writes a file of XYZ grid data.

write_xyzgrid_surface gnufor Subroutine

WRITE_XYZGRID_SURFACE writes a file of GNUPLOT commands to plot a 3D surface.

write_y_plot gnufor Subroutine

WRITE_Y_PLOT writes GNUPLOT commands to plot Y(1:N) data.

call~~graph~~CallGraph interface~c_umfpack_di_defaults c_umfpack_di_defaults interface~c_umfpack_di_free_numeric c_umfpack_di_free_numeric interface~c_umfpack_di_free_symbolic c_umfpack_di_free_symbolic interface~c_umfpack_di_load_numeric c_umfpack_di_load_numeric interface~c_umfpack_di_load_symbolic c_umfpack_di_load_symbolic interface~c_umfpack_di_numeric c_umfpack_di_numeric interface~c_umfpack_di_report_control c_umfpack_di_report_control interface~c_umfpack_di_report_info c_umfpack_di_report_info interface~c_umfpack_di_report_numeric c_umfpack_di_report_numeric interface~c_umfpack_di_report_status c_umfpack_di_report_status interface~c_umfpack_di_report_symbolic c_umfpack_di_report_symbolic interface~c_umfpack_di_save_numeric c_umfpack_di_save_numeric interface~c_umfpack_di_save_symbolic c_umfpack_di_save_symbolic interface~c_umfpack_di_scale c_umfpack_di_scale interface~c_umfpack_di_solve c_umfpack_di_solve interface~c_umfpack_di_symbolic c_umfpack_di_symbolic interface~c_umfpack_zi_defaults c_umfpack_zi_defaults interface~c_umfpack_zi_free_numeric c_umfpack_zi_free_numeric interface~c_umfpack_zi_free_symbolic c_umfpack_zi_free_symbolic interface~c_umfpack_zi_load_numeric c_umfpack_zi_load_numeric interface~c_umfpack_zi_load_symbolic c_umfpack_zi_load_symbolic interface~c_umfpack_zi_numeric c_umfpack_zi_numeric interface~c_umfpack_zi_report_control c_umfpack_zi_report_control interface~c_umfpack_zi_report_info c_umfpack_zi_report_info interface~c_umfpack_zi_report_numeric c_umfpack_zi_report_numeric interface~c_umfpack_zi_report_status c_umfpack_zi_report_status interface~c_umfpack_zi_report_symbolic c_umfpack_zi_report_symbolic interface~c_umfpack_zi_save_numeric c_umfpack_zi_save_numeric interface~c_umfpack_zi_save_symbolic c_umfpack_zi_save_symbolic interface~c_umfpack_zi_scale c_umfpack_zi_scale interface~c_umfpack_zi_solve c_umfpack_zi_solve interface~c_umfpack_zi_symbolic c_umfpack_zi_symbolic interface~dcreate_compcol_matrix dCreate_CompCol_Matrix interface~dcreate_dense_matrix dCreate_Dense_Matrix interface~destroy_compcol_matrix Destroy_CompCol_Matrix interface~destroy_dense_matrix Destroy_Dense_Matrix interface~destroy_supermatrix_store Destroy_SuperMatrix_Store interface~destroy_supernode_matrix Destroy_SuperNode_Matrix interface~dgssvx dgssvx interface~fftw_alignment_of fftw_alignment_of interface~fftw_alloc_complex fftw_alloc_complex interface~fftw_alloc_real fftw_alloc_real interface~fftw_cleanup fftw_cleanup interface~fftw_cleanup_threads fftw_cleanup_threads interface~fftw_cost fftw_cost interface~fftw_destroy_plan fftw_destroy_plan interface~fftw_estimate_cost fftw_estimate_cost interface~fftw_execute_dft fftw_execute_dft interface~fftw_execute_dft_c2r fftw_execute_dft_c2r interface~fftw_execute_dft_r2c fftw_execute_dft_r2c interface~fftw_execute_r2r fftw_execute_r2r interface~fftw_execute_split_dft fftw_execute_split_dft interface~fftw_execute_split_dft_c2r fftw_execute_split_dft_c2r interface~fftw_execute_split_dft_r2c fftw_execute_split_dft_r2c interface~fftw_export_wisdom fftw_export_wisdom interface~fftw_export_wisdom_to_file fftw_export_wisdom_to_file interface~fftw_export_wisdom_to_filename fftw_export_wisdom_to_filename interface~fftw_export_wisdom_to_string fftw_export_wisdom_to_string interface~fftw_flops fftw_flops interface~fftw_forget_wisdom fftw_forget_wisdom interface~fftw_fprint_plan fftw_fprint_plan interface~fftw_free fftw_free interface~fftw_import_system_wisdom fftw_import_system_wisdom interface~fftw_import_wisdom fftw_import_wisdom interface~fftw_import_wisdom_from_file fftw_import_wisdom_from_file interface~fftw_import_wisdom_from_filename fftw_import_wisdom_from_filename interface~fftw_import_wisdom_from_string fftw_import_wisdom_from_string interface~fftw_init_threads fftw_init_threads interface~fftw_make_planner_thread_safe fftw_make_planner_thread_safe interface~fftw_malloc fftw_malloc interface~fftw_plan_dft fftw_plan_dft interface~fftw_plan_dft_1d fftw_plan_dft_1d interface~fftw_plan_dft_2d fftw_plan_dft_2d interface~fftw_plan_dft_3d fftw_plan_dft_3d interface~fftw_plan_dft_c2r fftw_plan_dft_c2r interface~fftw_plan_dft_c2r_1d fftw_plan_dft_c2r_1d interface~fftw_plan_dft_c2r_2d fftw_plan_dft_c2r_2d interface~fftw_plan_dft_c2r_3d fftw_plan_dft_c2r_3d interface~fftw_plan_dft_r2c fftw_plan_dft_r2c interface~fftw_plan_dft_r2c_1d fftw_plan_dft_r2c_1d interface~fftw_plan_dft_r2c_2d fftw_plan_dft_r2c_2d interface~fftw_plan_dft_r2c_3d fftw_plan_dft_r2c_3d interface~fftw_plan_guru64_dft fftw_plan_guru64_dft interface~fftw_plan_guru64_dft_c2r fftw_plan_guru64_dft_c2r interface~fftw_plan_guru64_dft_r2c fftw_plan_guru64_dft_r2c interface~fftw_plan_guru64_r2r fftw_plan_guru64_r2r interface~fftw_plan_guru64_split_dft fftw_plan_guru64_split_dft interface~fftw_plan_guru64_split_dft_c2r fftw_plan_guru64_split_dft_c2r interface~fftw_plan_guru64_split_dft_r2c fftw_plan_guru64_split_dft_r2c interface~fftw_plan_guru_dft fftw_plan_guru_dft interface~fftw_plan_guru_dft_c2r fftw_plan_guru_dft_c2r interface~fftw_plan_guru_dft_r2c fftw_plan_guru_dft_r2c interface~fftw_plan_guru_r2r fftw_plan_guru_r2r interface~fftw_plan_guru_split_dft fftw_plan_guru_split_dft interface~fftw_plan_guru_split_dft_c2r fftw_plan_guru_split_dft_c2r interface~fftw_plan_guru_split_dft_r2c fftw_plan_guru_split_dft_r2c interface~fftw_plan_many_dft fftw_plan_many_dft interface~fftw_plan_many_dft_c2r fftw_plan_many_dft_c2r interface~fftw_plan_many_dft_r2c fftw_plan_many_dft_r2c interface~fftw_plan_many_r2r fftw_plan_many_r2r interface~fftw_plan_r2r fftw_plan_r2r interface~fftw_plan_r2r_1d fftw_plan_r2r_1d interface~fftw_plan_r2r_2d fftw_plan_r2r_2d interface~fftw_plan_r2r_3d fftw_plan_r2r_3d interface~fftw_plan_with_nthreads fftw_plan_with_nthreads interface~fftw_planner_nthreads fftw_planner_nthreads interface~fftw_print_plan fftw_print_plan interface~fftw_set_timelimit fftw_set_timelimit interface~fftw_sprint_plan fftw_sprint_plan interface~fftwf_alignment_of fftwf_alignment_of interface~fftwf_alloc_complex fftwf_alloc_complex interface~fftwf_alloc_real fftwf_alloc_real interface~fftwf_cleanup fftwf_cleanup interface~fftwf_cleanup_threads fftwf_cleanup_threads interface~fftwf_cost fftwf_cost interface~fftwf_destroy_plan fftwf_destroy_plan interface~fftwf_estimate_cost fftwf_estimate_cost interface~fftwf_execute_dft fftwf_execute_dft interface~fftwf_execute_dft_c2r fftwf_execute_dft_c2r interface~fftwf_execute_dft_r2c fftwf_execute_dft_r2c interface~fftwf_execute_r2r fftwf_execute_r2r interface~fftwf_execute_split_dft fftwf_execute_split_dft interface~fftwf_execute_split_dft_c2r fftwf_execute_split_dft_c2r interface~fftwf_execute_split_dft_r2c fftwf_execute_split_dft_r2c interface~fftwf_export_wisdom fftwf_export_wisdom interface~fftwf_export_wisdom_to_file fftwf_export_wisdom_to_file interface~fftwf_export_wisdom_to_filename fftwf_export_wisdom_to_filename interface~fftwf_export_wisdom_to_string fftwf_export_wisdom_to_string interface~fftwf_flops fftwf_flops interface~fftwf_forget_wisdom fftwf_forget_wisdom interface~fftwf_fprint_plan fftwf_fprint_plan interface~fftwf_free fftwf_free interface~fftwf_import_system_wisdom fftwf_import_system_wisdom interface~fftwf_import_wisdom fftwf_import_wisdom interface~fftwf_import_wisdom_from_file fftwf_import_wisdom_from_file interface~fftwf_import_wisdom_from_filename fftwf_import_wisdom_from_filename interface~fftwf_import_wisdom_from_string fftwf_import_wisdom_from_string interface~fftwf_init_threads fftwf_init_threads interface~fftwf_make_planner_thread_safe fftwf_make_planner_thread_safe interface~fftwf_malloc fftwf_malloc interface~fftwf_plan_dft fftwf_plan_dft interface~fftwf_plan_dft_1d fftwf_plan_dft_1d interface~fftwf_plan_dft_2d fftwf_plan_dft_2d interface~fftwf_plan_dft_3d fftwf_plan_dft_3d interface~fftwf_plan_dft_c2r fftwf_plan_dft_c2r interface~fftwf_plan_dft_c2r_1d fftwf_plan_dft_c2r_1d interface~fftwf_plan_dft_c2r_2d fftwf_plan_dft_c2r_2d interface~fftwf_plan_dft_c2r_3d fftwf_plan_dft_c2r_3d interface~fftwf_plan_dft_r2c fftwf_plan_dft_r2c interface~fftwf_plan_dft_r2c_1d fftwf_plan_dft_r2c_1d interface~fftwf_plan_dft_r2c_2d fftwf_plan_dft_r2c_2d interface~fftwf_plan_dft_r2c_3d fftwf_plan_dft_r2c_3d interface~fftwf_plan_guru64_dft fftwf_plan_guru64_dft interface~fftwf_plan_guru64_dft_c2r fftwf_plan_guru64_dft_c2r interface~fftwf_plan_guru64_dft_r2c fftwf_plan_guru64_dft_r2c interface~fftwf_plan_guru64_r2r fftwf_plan_guru64_r2r interface~fftwf_plan_guru64_split_dft fftwf_plan_guru64_split_dft interface~fftwf_plan_guru64_split_dft_c2r fftwf_plan_guru64_split_dft_c2r interface~fftwf_plan_guru64_split_dft_r2c fftwf_plan_guru64_split_dft_r2c interface~fftwf_plan_guru_dft fftwf_plan_guru_dft interface~fftwf_plan_guru_dft_c2r fftwf_plan_guru_dft_c2r interface~fftwf_plan_guru_dft_r2c fftwf_plan_guru_dft_r2c interface~fftwf_plan_guru_r2r fftwf_plan_guru_r2r interface~fftwf_plan_guru_split_dft fftwf_plan_guru_split_dft interface~fftwf_plan_guru_split_dft_c2r fftwf_plan_guru_split_dft_c2r interface~fftwf_plan_guru_split_dft_r2c fftwf_plan_guru_split_dft_r2c interface~fftwf_plan_many_dft fftwf_plan_many_dft interface~fftwf_plan_many_dft_c2r fftwf_plan_many_dft_c2r interface~fftwf_plan_many_dft_r2c fftwf_plan_many_dft_r2c interface~fftwf_plan_many_r2r fftwf_plan_many_r2r interface~fftwf_plan_r2r fftwf_plan_r2r interface~fftwf_plan_r2r_1d fftwf_plan_r2r_1d interface~fftwf_plan_r2r_2d fftwf_plan_r2r_2d interface~fftwf_plan_r2r_3d fftwf_plan_r2r_3d interface~fftwf_plan_with_nthreads fftwf_plan_with_nthreads interface~fftwf_planner_nthreads fftwf_planner_nthreads interface~fftwf_print_plan fftwf_print_plan interface~fftwf_set_timelimit fftwf_set_timelimit interface~fftwf_sprint_plan fftwf_sprint_plan interface~operator(.umfpack.) operator(.umfpack.) proc~umfpack_ci_operator_csc umfpack_ci_operator_CSC interface~operator(.umfpack.)->proc~umfpack_ci_operator_csc proc~umfpack_ci_operator_csr umfpack_ci_operator_CSR interface~operator(.umfpack.)->proc~umfpack_ci_operator_csr proc~umfpack_ci_operator_pcsc umfpack_ci_operator_pCSC interface~operator(.umfpack.)->proc~umfpack_ci_operator_pcsc proc~umfpack_ci_operator_pcsr umfpack_ci_operator_pCSR interface~operator(.umfpack.)->proc~umfpack_ci_operator_pcsr proc~umfpack_di_operator_csc umfpack_di_operator_CSC interface~operator(.umfpack.)->proc~umfpack_di_operator_csc proc~umfpack_di_operator_csr umfpack_di_operator_CSR interface~operator(.umfpack.)->proc~umfpack_di_operator_csr proc~umfpack_di_operator_pcsc umfpack_di_operator_pCSC interface~operator(.umfpack.)->proc~umfpack_di_operator_pcsc proc~umfpack_di_operator_pcsr umfpack_di_operator_pCSR interface~operator(.umfpack.)->proc~umfpack_di_operator_pcsr proc~umfpack_zi_operator_csc umfpack_zi_operator_CSC interface~operator(.umfpack.)->proc~umfpack_zi_operator_csc proc~umfpack_zi_operator_csr umfpack_zi_operator_CSR interface~operator(.umfpack.)->proc~umfpack_zi_operator_csr proc~umfpack_zi_operator_pcsc umfpack_zi_operator_pCSC interface~operator(.umfpack.)->proc~umfpack_zi_operator_pcsc proc~umfpack_zi_operator_pcsr umfpack_zi_operator_pCSR interface~operator(.umfpack.)->proc~umfpack_zi_operator_pcsr interface~pcsc pCSC proc~make_csc_ci make_CSC_ci interface~pcsc->proc~make_csc_ci proc~make_csc_di make_CSC_di interface~pcsc->proc~make_csc_di proc~make_csc_zi make_CSC_zi interface~pcsc->proc~make_csc_zi interface~pcsr pCSR proc~make_csr_ci make_CSR_ci interface~pcsr->proc~make_csr_ci proc~make_csr_di make_CSR_di interface~pcsr->proc~make_csr_di proc~make_csr_zi make_CSR_zi interface~pcsr->proc~make_csr_zi interface~pvec pVec proc~make_vec_zi make_Vec_zi interface~pvec->proc~make_vec_zi interface~s_umfpack_defaults s_umfpack_defaults proc~umfpack_defaults umfpack_defaults interface~s_umfpack_defaults->proc~umfpack_defaults interface~s_umfpack_di_defaults s_umfpack_di_defaults proc~umfpack_di_defaults umfpack_di_defaults interface~s_umfpack_di_defaults->proc~umfpack_di_defaults interface~s_umfpack_di_free_numeric s_umfpack_di_free_numeric proc~umfpack_di_free_numeric umfpack_di_free_numeric interface~s_umfpack_di_free_numeric->proc~umfpack_di_free_numeric interface~s_umfpack_di_free_symbolic s_umfpack_di_free_symbolic proc~umfpack_di_free_symbolic umfpack_di_free_symbolic interface~s_umfpack_di_free_symbolic->proc~umfpack_di_free_symbolic interface~s_umfpack_di_report_control s_umfpack_di_report_control proc~umfpack_di_report_control umfpack_di_report_control interface~s_umfpack_di_report_control->proc~umfpack_di_report_control interface~s_umfpack_di_report_info s_umfpack_di_report_info proc~umfpack_di_report_info umfpack_di_report_info interface~s_umfpack_di_report_info->proc~umfpack_di_report_info interface~s_umfpack_free_numeric s_umfpack_free_numeric proc~umfpack_free_numeric umfpack_free_numeric interface~s_umfpack_free_numeric->proc~umfpack_free_numeric interface~s_umfpack_free_symbolic s_umfpack_free_symbolic proc~umfpack_free_symbolic umfpack_free_symbolic interface~s_umfpack_free_symbolic->proc~umfpack_free_symbolic interface~s_umfpack_numeric s_umfpack_numeric interface~s_umfpack_zi_numeric s_umfpack_zi_numeric interface~s_umfpack_numeric->interface~s_umfpack_zi_numeric proc~s_umfpack_ci_numeric s_umfpack_ci_numeric interface~s_umfpack_numeric->proc~s_umfpack_ci_numeric proc~s_umfpack_di_numeric s_umfpack_di_numeric interface~s_umfpack_numeric->proc~s_umfpack_di_numeric interface~s_umfpack_report_control s_umfpack_report_control proc~umfpack_report_control umfpack_report_control interface~s_umfpack_report_control->proc~umfpack_report_control interface~s_umfpack_report_info s_umfpack_report_info proc~umfpack_report_info umfpack_report_info interface~s_umfpack_report_info->proc~umfpack_report_info interface~s_umfpack_scale s_umfpack_scale interface~s_umfpack_zi_scale s_umfpack_zi_scale interface~s_umfpack_scale->interface~s_umfpack_zi_scale proc~s_umfpack_ci_scale s_umfpack_ci_scale interface~s_umfpack_scale->proc~s_umfpack_ci_scale proc~s_umfpack_di_scale s_umfpack_di_scale interface~s_umfpack_scale->proc~s_umfpack_di_scale interface~s_umfpack_solve s_umfpack_solve interface~s_umfpack_zi_solve s_umfpack_zi_solve interface~s_umfpack_solve->interface~s_umfpack_zi_solve proc~s_umfpack_ci_solve s_umfpack_ci_solve interface~s_umfpack_solve->proc~s_umfpack_ci_solve proc~s_umfpack_di_solve s_umfpack_di_solve interface~s_umfpack_solve->proc~s_umfpack_di_solve interface~s_umfpack_symbolic s_umfpack_symbolic interface~s_umfpack_zi_symbolic s_umfpack_zi_symbolic interface~s_umfpack_symbolic->interface~s_umfpack_zi_symbolic proc~s_umfpack_ci_symbolic s_umfpack_ci_symbolic interface~s_umfpack_symbolic->proc~s_umfpack_ci_symbolic proc~s_umfpack_di_symbolic s_umfpack_di_symbolic interface~s_umfpack_symbolic->proc~s_umfpack_di_symbolic interface~s_umfpack_zi_defaults s_umfpack_zi_defaults proc~umfpack_zi_defaults umfpack_zi_defaults interface~s_umfpack_zi_defaults->proc~umfpack_zi_defaults interface~s_umfpack_zi_free_numeric s_umfpack_zi_free_numeric proc~umfpack_zi_free_numeric umfpack_zi_free_numeric interface~s_umfpack_zi_free_numeric->proc~umfpack_zi_free_numeric interface~s_umfpack_zi_free_symbolic s_umfpack_zi_free_symbolic proc~umfpack_zi_free_symbolic umfpack_zi_free_symbolic interface~s_umfpack_zi_free_symbolic->proc~umfpack_zi_free_symbolic interface~s_umfpack_zi_numeric->interface~s_umfpack_zi_numeric interface~s_umfpack_zi_numeric->proc~s_umfpack_ci_numeric interface~s_umfpack_zi_report_control s_umfpack_zi_report_control proc~umfpack_zi_report_control umfpack_zi_report_control interface~s_umfpack_zi_report_control->proc~umfpack_zi_report_control interface~s_umfpack_zi_report_info s_umfpack_zi_report_info proc~umfpack_zi_report_info umfpack_zi_report_info interface~s_umfpack_zi_report_info->proc~umfpack_zi_report_info interface~s_umfpack_zi_scale->interface~s_umfpack_zi_scale interface~s_umfpack_zi_scale->proc~s_umfpack_ci_scale interface~s_umfpack_zi_solve->interface~s_umfpack_zi_solve interface~s_umfpack_zi_solve->proc~s_umfpack_ci_solve interface~s_umfpack_zi_symbolic->interface~s_umfpack_zi_symbolic interface~s_umfpack_zi_symbolic->proc~s_umfpack_ci_symbolic interface~set_default_options set_default_options interface~statfree StatFree interface~statinit StatInit interface~statprint StatPrint interface~umf4cfnum umf4cfnum interface~umf4cfnum->interface~umf4cfnum proc~umf4cfnum_ip umf4cfnum_ip interface~umf4cfnum->proc~umf4cfnum_ip interface~umf4cfsym umf4cfsym interface~umf4cfsym->interface~umf4cfsym proc~umf4cfsym_ip umf4cfsym_ip interface~umf4cfsym->proc~umf4cfsym_ip interface~umf4clnum umf4clnum interface~umf4clnum->interface~umf4clnum proc~umf4clnum_ip umf4clnum_ip interface~umf4clnum->proc~umf4clnum_ip interface~umf4clsym umf4clsym interface~umf4clsym->interface~umf4clsym proc~umf4clsym_ip umf4clsym_ip interface~umf4clsym->proc~umf4clsym_ip interface~umf4cnum umf4cnum interface~umf4cnum->interface~umf4cnum proc~umf4cnum_ip umf4cnum_ip interface~umf4cnum->proc~umf4cnum_ip interface~umf4cscal umf4cscal interface~umf4cscal->interface~umf4cscal proc~umf4cscal_ip umf4cscal_ip interface~umf4cscal->proc~umf4cscal_ip interface~umf4csnum umf4csnum interface~umf4csnum->interface~umf4csnum proc~umf4csnum_ip umf4csnum_ip interface~umf4csnum->proc~umf4csnum_ip interface~umf4csol umf4csol interface~umf4csol->interface~umf4csol proc~umf4csol_ip umf4csol_ip interface~umf4csol->proc~umf4csol_ip interface~umf4csolr umf4csolr interface~umf4csolr->interface~umf4csolr proc~umf4csolr_ip umf4csolr_ip interface~umf4csolr->proc~umf4csolr_ip interface~umf4cssym umf4cssym interface~umf4cssym->interface~umf4cssym proc~umf4cssym_ip umf4cssym_ip interface~umf4cssym->proc~umf4cssym_ip interface~umf4csym umf4csym interface~umf4csym->interface~umf4csym proc~umf4csym_ip umf4csym_ip interface~umf4csym->proc~umf4csym_ip interface~umf4fnum umf4fnum interface~umf4fnum->interface~umf4fnum proc~umf4fnum_ip umf4fnum_ip interface~umf4fnum->proc~umf4fnum_ip interface~umf4fsym umf4fsym interface~umf4fsym->interface~umf4fsym proc~umf4fsym_ip umf4fsym_ip interface~umf4fsym->proc~umf4fsym_ip interface~umf4lnum umf4lnum interface~umf4lnum->interface~umf4lnum proc~umf4lnum_ip umf4lnum_ip interface~umf4lnum->proc~umf4lnum_ip interface~umf4lsym umf4lsym interface~umf4lsym->interface~umf4lsym proc~umf4lsym_ip umf4lsym_ip interface~umf4lsym->proc~umf4lsym_ip interface~umf4num umf4num interface~umf4num->interface~umf4cnum interface~umf4num->interface~umf4num interface~umf4znum umf4znum interface~umf4num->interface~umf4znum interface~umf4num->proc~umf4cnum_ip proc~umf4num_ip umf4num_ip interface~umf4num->proc~umf4num_ip proc~umf4znum_ip umf4znum_ip interface~umf4num->proc~umf4znum_ip interface~umf4scal umf4scal interface~umf4scal->interface~umf4cscal interface~umf4scal->interface~umf4scal interface~umf4zscal umf4zscal interface~umf4scal->interface~umf4zscal interface~umf4scal->proc~umf4cscal_ip proc~umf4scal_ip umf4scal_ip interface~umf4scal->proc~umf4scal_ip proc~umf4zscal_ip umf4zscal_ip interface~umf4scal->proc~umf4zscal_ip interface~umf4snum umf4snum interface~umf4snum->interface~umf4snum proc~umf4snum_ip umf4snum_ip interface~umf4snum->proc~umf4snum_ip interface~umf4sol umf4sol interface~umf4sol->interface~umf4csol interface~umf4sol->interface~umf4sol interface~umf4zsol umf4zsol interface~umf4sol->interface~umf4zsol interface~umf4sol->proc~umf4csol_ip proc~umf4sol_ip umf4sol_ip interface~umf4sol->proc~umf4sol_ip proc~umf4zsol_ip umf4zsol_ip interface~umf4sol->proc~umf4zsol_ip interface~umf4solr umf4solr interface~umf4solr->interface~umf4csolr interface~umf4solr->interface~umf4solr interface~umf4zsolr umf4zsolr interface~umf4solr->interface~umf4zsolr interface~umf4solr->proc~umf4csolr_ip proc~umf4solr_ip umf4solr_ip interface~umf4solr->proc~umf4solr_ip proc~umf4zsolr_ip umf4zsolr_ip interface~umf4solr->proc~umf4zsolr_ip interface~umf4ssym umf4ssym interface~umf4ssym->interface~umf4ssym proc~umf4ssym_ip umf4ssym_ip interface~umf4ssym->proc~umf4ssym_ip interface~umf4sym umf4sym interface~umf4sym->interface~umf4csym interface~umf4sym->interface~umf4sym interface~umf4zsym umf4zsym interface~umf4sym->interface~umf4zsym interface~umf4sym->proc~umf4csym_ip proc~umf4sym_ip umf4sym_ip interface~umf4sym->proc~umf4sym_ip proc~umf4zsym_ip umf4zsym_ip interface~umf4sym->proc~umf4zsym_ip interface~umf4zfnum umf4zfnum interface~umf4zfnum->interface~umf4zfnum proc~umf4zfnum_ip umf4zfnum_ip interface~umf4zfnum->proc~umf4zfnum_ip interface~umf4zfsym umf4zfsym interface~umf4zfsym->interface~umf4zfsym proc~umf4zfsym_ip umf4zfsym_ip interface~umf4zfsym->proc~umf4zfsym_ip interface~umf4zlnum umf4zlnum interface~umf4zlnum->interface~umf4zlnum proc~umf4zlnum_ip umf4zlnum_ip interface~umf4zlnum->proc~umf4zlnum_ip interface~umf4zlsym umf4zlsym interface~umf4zlsym->interface~umf4zlsym proc~umf4zlsym_ip umf4zlsym_ip interface~umf4zlsym->proc~umf4zlsym_ip interface~umf4znum->interface~umf4cnum interface~umf4znum->interface~umf4znum interface~umf4znum->proc~umf4cnum_ip interface~umf4znum->proc~umf4znum_ip interface~umf4zscal->interface~umf4cscal interface~umf4zscal->interface~umf4zscal interface~umf4zscal->proc~umf4cscal_ip interface~umf4zscal->proc~umf4zscal_ip interface~umf4zsnum umf4zsnum interface~umf4zsnum->interface~umf4zsnum proc~umf4zsnum_ip umf4zsnum_ip interface~umf4zsnum->proc~umf4zsnum_ip interface~umf4zsol->interface~umf4csol interface~umf4zsol->interface~umf4zsol interface~umf4zsol->proc~umf4csol_ip interface~umf4zsol->proc~umf4zsol_ip interface~umf4zsolr->interface~umf4csolr interface~umf4zsolr->interface~umf4zsolr interface~umf4zsolr->proc~umf4csolr_ip interface~umf4zsolr->proc~umf4zsolr_ip interface~umf4zssym umf4zssym interface~umf4zssym->interface~umf4zssym proc~umf4zssym_ip umf4zssym_ip interface~umf4zssym->proc~umf4zssym_ip interface~umf4zsym->interface~umf4csym interface~umf4zsym->interface~umf4zsym interface~umf4zsym->proc~umf4csym_ip interface~umf4zsym->proc~umf4zsym_ip interface~umfpack_numeric umfpack_numeric interface~umfpack_zi_numeric umfpack_zi_numeric interface~umfpack_numeric->interface~umfpack_zi_numeric proc~umfpack_ci_numeric umfpack_ci_numeric interface~umfpack_numeric->proc~umfpack_ci_numeric proc~umfpack_di_numeric umfpack_di_numeric interface~umfpack_numeric->proc~umfpack_di_numeric interface~umfpack_scale_function umfpack_scale_function interface~umfpack_zi_scale umfpack_zi_scale interface~umfpack_scale_function->interface~umfpack_zi_scale proc~umfpack_ci_scale umfpack_ci_scale interface~umfpack_scale_function->proc~umfpack_ci_scale proc~umfpack_di_scale umfpack_di_scale interface~umfpack_scale_function->proc~umfpack_di_scale interface~umfpack_solve umfpack_solve interface~umfpack_zi_solve umfpack_zi_solve interface~umfpack_solve->interface~umfpack_zi_solve proc~umfpack_ci_solve umfpack_ci_solve interface~umfpack_solve->proc~umfpack_ci_solve proc~umfpack_di_solve umfpack_di_solve interface~umfpack_solve->proc~umfpack_di_solve interface~umfpack_symbolic umfpack_symbolic interface~umfpack_zi_symbolic umfpack_zi_symbolic interface~umfpack_symbolic->interface~umfpack_zi_symbolic proc~umfpack_ci_symbolic umfpack_ci_symbolic interface~umfpack_symbolic->proc~umfpack_ci_symbolic proc~umfpack_di_symbolic umfpack_di_symbolic interface~umfpack_symbolic->proc~umfpack_di_symbolic interface~umfpack_zi_numeric->interface~umfpack_zi_numeric interface~umfpack_zi_numeric->proc~umfpack_ci_numeric interface~umfpack_zi_scale->interface~umfpack_zi_scale interface~umfpack_zi_scale->proc~umfpack_ci_scale interface~umfpack_zi_solve->interface~umfpack_zi_solve interface~umfpack_zi_solve->proc~umfpack_ci_solve interface~umfpack_zi_symbolic->interface~umfpack_zi_symbolic interface~umfpack_zi_symbolic->proc~umfpack_ci_symbolic none~initialize mt19937%initialize proc~init_by_array64 mt19937%init_by_array64 none~initialize->proc~init_by_array64 proc~init_genrand64 mt19937%init_genrand64 none~initialize->proc~init_genrand64 proc~init_genrand64_i4 mt19937%init_genrand64_i4 none~initialize->proc~init_genrand64_i4 proc~abs_diff_sk_ku abs_diff_sk_ku proc~sk_ku sk_ku proc~abs_diff_sk_ku->proc~sk_ku proc~add_tang add_tang proc~tang tang proc~add_tang->proc~tang proc~adjmut pikaia_class%adjmut proc~alloc_fftw3 alloc_fftw3 proc~alloc_fftw3->interface~fftw_alloc_complex proc~alloc_fftw3_real alloc_fftw3_real proc~alloc_fftw3_real->interface~fftw_alloc_complex proc~alloc_fftw3_real->interface~fftw_alloc_real proc~analyse_solver analyse_solver proc~prep_superlu prep_superlu proc~analyse_solver->proc~prep_superlu proc~analyse_solver->proc~s_umfpack_di_symbolic dmumps dmumps proc~analyse_solver->dmumps ma48_analyse ma48_analyse proc~analyse_solver->ma48_analyse proc~apod apod proc~autocov_impo autocov_impo proc~build_surf build_surf proc~unit2iuc unit2IUc proc~build_surf->proc~unit2iuc proc~c_f_string c_f_string proc~empty empty proc~c_f_string->proc~empty proc~calc_fftw3 calc_fftw3 proc~calc_fftw3->interface~fftw_execute_dft proc~calc_fftw3->interface~fftw_plan_with_nthreads proc~end_fftw3 end_fftw3 proc~calc_fftw3->proc~end_fftw3 proc~init_fftw3 init_fftw3 proc~calc_fftw3->proc~init_fftw3 omp_get_num_procs omp_get_num_procs proc~calc_fftw3->omp_get_num_procs proc~calc_fftw3_real_bwd calc_fftw3_real_bwd proc~calc_fftw3_real_bwd->interface~fftw_execute_dft_c2r proc~calc_fftw3_real_bwd->interface~fftw_plan_with_nthreads proc~calc_fftw3_real_bwd->proc~end_fftw3 proc~init_fftw3_real init_fftw3_real proc~calc_fftw3_real_bwd->proc~init_fftw3_real proc~calc_fftw3_real_bwd->omp_get_num_procs proc~calc_fftw3_real_fwd calc_fftw3_real_fwd proc~calc_fftw3_real_fwd->interface~fftw_execute_dft_r2c proc~calc_fftw3_real_fwd->interface~fftw_plan_with_nthreads proc~calc_fftw3_real_fwd->proc~end_fftw3 proc~calc_fftw3_real_fwd->proc~init_fftw3_real proc~calc_fftw3_real_fwd->omp_get_num_procs proc~calc_imp_acf calc_imp_acf proc~calc_imp_acf->proc~autocov_impo proc~calc_jf calc_Jf proc~df df proc~calc_jf->proc~df proc~calc_moments_1d calc_moments_1D proc~change_array_order change_array_order proc~check_inputs check_inputs proc~chkder chkder proc~chkder_f chkder_f proc~chkder_test chkder_test proc~chkder_test->proc~chkder proc~chkder_test->proc~chkder_f proc~r8vec_print r8vec_print proc~chkder_test->proc~r8vec_print proc~choldc choldc proc~cholsl cholsl proc~clean_scratch clean_scratch proc~close_solver close_solver proc~close_superlu close_superlu proc~close_solver->proc~close_superlu proc~close_solver->proc~umfpack_di_free_numeric proc~close_solver->proc~umfpack_di_free_symbolic proc~close_solver->proc~umfpack_di_report_info proc~close_solver->dmumps infog infog proc~close_solver->infog ma48_finalize ma48_finalize proc~close_solver->ma48_finalize mpi_finalize mpi_finalize proc~close_solver->mpi_finalize proc~close_superlu->interface~destroy_compcol_matrix proc~close_superlu->interface~destroy_dense_matrix proc~coeff_poly_tcheby_xy_vers_poly_monome coeff_poly_tcheby_xy_vers_poly_monome proc~coeff_tcheby_xy_vers_monome coeff_tcheby_xy_vers_monome proc~coeff_poly_tcheby_xy_vers_poly_monome->proc~coeff_tcheby_xy_vers_monome proc~coeff_tcheby_vers_monome coeff_tcheby_vers_monome proc~coeff_tcheby_xy_vers_monome->proc~coeff_tcheby_vers_monome proc~convert_matrice_format convert_matrice_format proc~from_elemental_to_assembled from_elemental_to_assembled proc~convert_matrice_format->proc~from_elemental_to_assembled proc~convert_to_poly convert_to_poly proc~cost cost proc~cost->proc~abs_diff_sk_ku proc~cost_func cost_func proc~cost_func->proc~abs_diff_sk_ku proc~cross pikaia_class%cross proc~urand pikaia_class%urand proc~cross->proc~urand proc~db1ink db1ink proc~db1ink->proc~check_inputs proc~dbknot dbknot proc~db1ink->proc~dbknot proc~dbtpcf dbtpcf proc~db1ink->proc~dbtpcf proc~db1val db1val proc~dbvalu dbvalu proc~db1val->proc~dbvalu proc~db2ink db2ink proc~db2ink->proc~check_inputs proc~db2ink->proc~dbknot proc~db2ink->proc~dbtpcf proc~db2val db2val proc~db2val->proc~dbvalu proc~dintrv dintrv proc~db2val->proc~dintrv proc~dbintk dbintk proc~dbnfac dbnfac proc~dbintk->proc~dbnfac proc~dbnslv dbnslv proc~dbintk->proc~dbnslv proc~dbspvn dbspvn proc~dbintk->proc~dbspvn proc~dbtpcf->proc~dbintk proc~dbtpcf->proc~dbnslv proc~dbvalu->proc~dintrv proc~decode pikaia_class%decode proc~def_tab1d def_tab1D proc~def_tab2d def_tab2D proc~desalloc_fftw3 desalloc_fftw3 proc~desalloc_fftw3->interface~fftw_free proc~destroy_plan_fftw3 destroy_plan_fftw3 proc~destroy_plan_fftw3->interface~fftw_destroy_plan proc~df->proc~autocov_impo proc~dir_separator dir_separator proc~is_linux is_linux proc~dir_separator->proc~is_linux proc~dirname dirname proc~dirname->proc~dir_separator proc~dogleg dogleg proc~enorm enorm proc~dogleg->proc~enorm proc~encode pikaia_class%encode proc~end_fftw3->proc~desalloc_fftw3 proc~end_fftw3->proc~destroy_plan_fftw3 proc~enorm2 enorm2 proc~extend extend proc~extend->proc~apod proc~f f proc~f->proc~autocov_impo proc~f_c_string f_c_string proc~fact_superlu fact_superlu proc~fact_superlu->interface~dgssvx proc~fact_superlu->interface~statfree proc~fact_superlu->interface~statinit proc~fact_superlu->interface~statprint proc~factorize_solver factorize_solver proc~factorize_solver->proc~fact_superlu proc~factorize_solver->proc~s_umfpack_di_numeric proc~factorize_solver->proc~umfpack_di_free_numeric proc~factorize_solver->dmumps ma48_factorize ma48_factorize proc~factorize_solver->ma48_factorize proc~fdjac1 fdjac1 proc~fdjac2 fdjac2 proc~filename filename proc~filename->proc~dir_separator proc~free_superlu free_superlu proc~freefact_solver freefact_solver proc~freefact_solver->proc~free_superlu proc~freefact_solver->proc~umfpack_di_free_numeric proc~sort_array2 sort_array2 proc~from_elemental_to_assembled->proc~sort_array2 proc~func func proc~func_wrapper pikaia_class%func_wrapper proc~genere_coeff_lagrange genere_coeff_lagrange proc~genere_surf_poly genere_surf_poly proc~genere_surf_poly->proc~coeff_tcheby_vers_monome proc~tcheby tcheby proc~genere_surf_poly->proc~tcheby proc~genrand64_int64 mt19937%genrand64_int64 proc~genrand64_int64->proc~init_genrand64 proc~genrand64_real1 mt19937%genrand64_real1 proc~genrand64_real1->proc~genrand64_int64 proc~genrand64_real2 mt19937%genrand64_real2 proc~genrand64_real2->proc~genrand64_int64 proc~genrand64_real3 mt19937%genrand64_real3 proc~genrand64_real3->proc~genrand64_int64 proc~genrep pikaia_class%genrep proc~get_unit get_unit proc~get_unit~2 get_unit proc~hybrd hybrd proc~hybrd->proc~dogleg proc~hybrd->proc~enorm proc~hybrd->proc~fdjac1 proc~qform qform proc~hybrd->proc~qform proc~qrfac qrfac proc~hybrd->proc~qrfac proc~r1mpyq r1mpyq proc~hybrd->proc~r1mpyq proc~r1updt r1updt proc~hybrd->proc~r1updt proc~hybrd1 hybrd1 proc~hybrd1->proc~hybrd proc~hybrd1_f hybrd1_f proc~hybrd1_test hybrd1_test proc~hybrd1_test->proc~hybrd1 proc~hybrd1_test->proc~hybrd1_f proc~hybrd1_test->proc~r8vec_print proc~hybrj hybrj proc~hybrj->proc~dogleg proc~hybrj->proc~enorm proc~hybrj->proc~qform proc~hybrj->proc~qrfac proc~hybrj->proc~r1mpyq proc~hybrj->proc~r1updt proc~hybrj1 hybrj1 proc~hybrj1->proc~hybrj proc~hybrj1_f hybrj1_f proc~hybrj1_test hybrj1_test proc~hybrj1_test->proc~hybrd1_f proc~hybrj1_test->proc~hybrj1 proc~hybrj1_test->proc~r8vec_print proc~init_by_array64->proc~init_genrand64 proc~init_fftw3->proc~alloc_fftw3 proc~make_plan_fftw3 make_plan_fftw3 proc~init_fftw3->proc~make_plan_fftw3 proc~init_fftw3_real->proc~alloc_fftw3_real proc~make_plan_fftw3_real make_plan_fftw3_real proc~init_fftw3_real->proc~make_plan_fftw3_real proc~init_genrand64_i4->none~initialize proc~init_order init_order proc~init_scal init_scal proc~init_scal->proc~empty proc~init_solver init_solver proc~init_superlu init_superlu proc~init_solver->proc~init_superlu proc~init_solver->proc~umfpack_di_defaults proc~init_solver->proc~umfpack_di_report_control proc~init_solver->dmumps icntl icntl proc~init_solver->icntl proc~init_solver->infog ma48_initialize ma48_initialize proc~init_solver->ma48_initialize proc~init_solver->mpi_finalize mpi_init mpi_init proc~init_solver->mpi_init proc~init_superlu->interface~set_default_options proc~interp interp proc~interp1d interp1D proc~interp1d->proc~interp proc~interp2d interp2D proc~interp2d->proc~interp1d proc~interp_surf interp_surf proc~interp_surf->proc~db2ink proc~interp_surf->proc~db2val proc~interp_surf->proc~func proc~least_squares_tcheby least_squares_tcheby proc~least_squares_tcheby->proc~coeff_poly_tcheby_xy_vers_poly_monome proc~least_squares_tcheby->proc~get_unit~2 proc~moindres_carres_lineaire moindres_carres_lineaire proc~least_squares_tcheby->proc~moindres_carres_lineaire proc~tab_jf_tcheby tab_Jf_tcheby proc~least_squares_tcheby->proc~tab_jf_tcheby proc~tab_poly_tcheby tab_poly_tcheby proc~least_squares_tcheby->proc~tab_poly_tcheby proc~tab_tcheby tab_tcheby proc~least_squares_tcheby->proc~tab_tcheby proc~list_dirs list_dirs proc~list_files list_files proc~list_files->proc~get_unit~2 proc~lmder lmder proc~lmder->proc~enorm proc~lmpar lmpar proc~lmder->proc~lmpar proc~lmder->proc~qrfac proc~lmder1 lmder1 proc~lmder1->proc~lmder proc~lmder1_2_f lmder1_2_f proc~lmder1_2_test lmder1_2_test proc~lmder1_2_test->proc~lmder1 proc~lmder1_2_test->proc~lmder1_2_f proc~lmder1_2_test->proc~r8vec_print proc~lmder1_f lmder1_f proc~lmder1_test lmder1_test proc~lmder1_test->proc~lmder1 proc~lmder1_test->proc~lmder1_f proc~lmder1_test->proc~r8vec_print proc~lmdif lmdif proc~lmdif->proc~enorm proc~lmdif->proc~fdjac2 proc~lmdif->proc~lmpar proc~lmdif->proc~qrfac proc~lmdif1 lmdif1 proc~lmdif1->proc~lmdif proc~lmdif1_2_f lmdif1_2_f proc~lmdif1_2_test lmdif1_2_test proc~lmdif1_2_test->proc~lmdif1 proc~lmdif1_2_test->proc~lmdif1_2_f proc~lmdif1_2_test->proc~r8vec_print proc~lmdif1_f lmdif1_f proc~lmdif1_test lmdif1_test proc~lmdif1_test->proc~lmdif1 proc~lmdif1_test->proc~lmdif1_f proc~lmdif1_test->proc~r8vec_print proc~lmpar->proc~enorm proc~qrsolv qrsolv proc~lmpar->proc~qrsolv proc~lmstr lmstr proc~lmstr->proc~enorm proc~lmstr->proc~lmpar proc~lmstr->proc~qrfac proc~rwupdt rwupdt proc~lmstr->proc~rwupdt proc~lmstr1 lmstr1 proc~lmstr1->proc~lmstr proc~lmstr1_2_f lmstr1_2_f proc~lmstr1_2_test lmstr1_2_test proc~lmstr1_2_test->proc~lmstr1 proc~lmstr1_2_test->proc~lmstr1_2_f proc~lmstr1_2_test->proc~r8vec_print proc~lmstr1_f lmstr1_f proc~lmstr1_test lmstr1_test proc~lmstr1_test->proc~lmstr1 proc~lmstr1_test->proc~lmstr1_f proc~lmstr1_test->proc~r8vec_print proc~lower lower proc~make_path make_path proc~make_path->proc~dir_separator proc~mkdir mkdir proc~make_path->proc~mkdir proc~make_plan_fftw3->interface~fftw_plan_dft_2d proc~make_plan_fftw3_real->interface~fftw_plan_dft_c2r_2d proc~make_plan_fftw3_real->interface~fftw_plan_dft_r2c_2d proc~melange melange proc~melange->proc~sort_array2 proc~modify_a_elt modify_a_elt proc~moindres_carres moindres_carres proc~moindres_carres->proc~choldc proc~moindres_carres->proc~cholsl proc~moindres_carres_lineaire->proc~choldc proc~moindres_carres_lineaire->proc~cholsl proc~mutate pikaia_class%mutate proc~mutate->proc~urand proc~newpop pikaia_class%newpop proc~newpop->proc~func_wrapper proc~rnkpop pikaia_class%rnkpop proc~newpop->proc~rnkpop proc~newton_raphson_downhill newton_raphson_downhill proc~newton_raphson_downhill->proc~abs_diff_sk_ku proc~open_surffile open_surffile proc~open_surffile->proc~get_unit~2 proc~surf2scal surf2scal proc~open_surffile->proc~surf2scal proc~trans_surf_txt trans_surf_txt proc~open_surffile->proc~trans_surf_txt proc~path2vec path2vec proc~path2vec->proc~dir_separator proc~pi pi proc~pikaia pikaia_class%pikaia proc~pikaia->proc~adjmut proc~pikaia->proc~cross proc~pikaia->proc~decode proc~pikaia->proc~encode proc~pikaia->proc~func_wrapper proc~pikaia->proc~genrep proc~pikaia->proc~mutate proc~pikaia->proc~newpop proc~report pikaia_class%report proc~pikaia->proc~report proc~rninit pikaia_class%rninit proc~pikaia->proc~rninit proc~pikaia->proc~rnkpop proc~select_parents pikaia_class%select_parents proc~pikaia->proc~select_parents proc~stdrep pikaia_class%stdrep proc~pikaia->proc~stdrep proc~pikaia->proc~urand proc~prep_superlu->interface~dcreate_compcol_matrix proc~prep_superlu->interface~dcreate_dense_matrix proc~prod_a_x prod_a_x proc~prod_elemental_x prod_elemental_x proc~profil_theo_trie_1d profil_theo_trie_1D proc~profil_theo_trie_1d->proc~calc_moments_1d proc~progress_bar_terminal progress_bar_terminal proc~qform_test qform_test proc~qform_test->proc~qform proc~qform_test->proc~qrfac proc~r8mat_print r8mat_print proc~qform_test->proc~r8mat_print proc~qrfac->proc~enorm proc~r8_uniform_01 r8_uniform_01 proc~r8mat_print_some r8mat_print_some proc~r8mat_print->proc~r8mat_print_some proc~read_surf read_surf proc~read_surf->proc~get_unit~2 proc~read_surf~2 read_surf proc~read_surf~2->proc~get_unit~2 proc~read_surf~2->proc~lower proc~read_surf~2->proc~open_surffile proc~read_surf~2->proc~sort_array2 proc~trans_surf_tab trans_surf_tab proc~read_surf~2->proc~trans_surf_tab proc~restrict restrict proc~restrict1d restrict1D proc~restrict1d->proc~restrict proc~restrict2d restrict2D proc~restrict2d->proc~restrict1d proc~rninit->none~initialize proc~rqsort rqsort proc~rnkpop->proc~rqsort proc~run_gnuplot run_gnuplot proc~s_umfpack_ci_numeric->proc~umfpack_ci_numeric proc~s_umfpack_ci_scale->proc~umfpack_ci_scale proc~s_umfpack_ci_solve->proc~umfpack_ci_solve proc~s_umfpack_ci_symbolic->proc~umfpack_ci_symbolic proc~s_umfpack_di_load_numeric s_umfpack_di_load_numeric proc~umfpack_di_load_numeric umfpack_di_load_numeric proc~s_umfpack_di_load_numeric->proc~umfpack_di_load_numeric proc~s_umfpack_di_load_symbolic s_umfpack_di_load_symbolic proc~umfpack_di_load_symbolic umfpack_di_load_symbolic proc~s_umfpack_di_load_symbolic->proc~umfpack_di_load_symbolic proc~s_umfpack_di_numeric->proc~umfpack_di_numeric proc~s_umfpack_di_save_numeric s_umfpack_di_save_numeric proc~umfpack_di_save_numeric umfpack_di_save_numeric proc~s_umfpack_di_save_numeric->proc~umfpack_di_save_numeric proc~s_umfpack_di_save_symbolic s_umfpack_di_save_symbolic proc~umfpack_di_save_symbolic umfpack_di_save_symbolic proc~s_umfpack_di_save_symbolic->proc~umfpack_di_save_symbolic proc~s_umfpack_di_scale->proc~umfpack_di_scale proc~s_umfpack_di_solve->proc~umfpack_di_solve proc~s_umfpack_di_symbolic->proc~umfpack_di_symbolic proc~s_umfpack_load_numeric s_umfpack_load_numeric proc~umfpack_load_numeric umfpack_load_numeric proc~s_umfpack_load_numeric->proc~umfpack_load_numeric proc~s_umfpack_load_symbolic s_umfpack_load_symbolic proc~umfpack_load_symbolic umfpack_load_symbolic proc~s_umfpack_load_symbolic->proc~umfpack_load_symbolic proc~s_umfpack_save_numeric s_umfpack_save_numeric proc~umfpack_save_numeric umfpack_save_numeric proc~s_umfpack_save_numeric->proc~umfpack_save_numeric proc~s_umfpack_save_symbolic s_umfpack_save_symbolic proc~umfpack_save_symbolic umfpack_save_symbolic proc~s_umfpack_save_symbolic->proc~umfpack_save_symbolic proc~s_umfpack_zi_load_numeric s_umfpack_zi_load_numeric proc~umfpack_zi_load_numeric umfpack_zi_load_numeric proc~s_umfpack_zi_load_numeric->proc~umfpack_zi_load_numeric proc~s_umfpack_zi_load_symbolic s_umfpack_zi_load_symbolic proc~umfpack_zi_load_symbolic umfpack_zi_load_symbolic proc~s_umfpack_zi_load_symbolic->proc~umfpack_zi_load_symbolic proc~s_umfpack_zi_numeric s_umfpack_zi_numeric proc~s_umfpack_zi_numeric->interface~umfpack_zi_numeric proc~s_umfpack_zi_save_numeric s_umfpack_zi_save_numeric proc~umfpack_zi_save_numeric umfpack_zi_save_numeric proc~s_umfpack_zi_save_numeric->proc~umfpack_zi_save_numeric proc~s_umfpack_zi_save_symbolic s_umfpack_zi_save_symbolic proc~umfpack_zi_save_symbolic umfpack_zi_save_symbolic proc~s_umfpack_zi_save_symbolic->proc~umfpack_zi_save_symbolic proc~s_umfpack_zi_scale s_umfpack_zi_scale proc~s_umfpack_zi_scale->interface~umfpack_zi_scale proc~s_umfpack_zi_solve s_umfpack_zi_solve proc~s_umfpack_zi_solve->interface~umfpack_zi_solve proc~s_umfpack_zi_symbolic s_umfpack_zi_symbolic proc~s_umfpack_zi_symbolic->interface~umfpack_zi_symbolic proc~save_surf save_surf proc~save_surf->proc~get_unit~2 proc~scal2surf scal2surf proc~scal2surf->proc~f_c_string proc~select_parents->proc~urand proc~set_inputs pikaia_class%set_inputs proc~sk_ku->proc~add_tang proc~sk_ku->proc~tang proc~solution_solver solution_solver proc~solution_solver->proc~s_umfpack_di_solve proc~solv_superlu solv_superlu proc~solution_solver->proc~solv_superlu proc~solve_syst solve_syst proc~solution_solver->proc~solve_syst proc~solution_solver->dmumps proc~solution_solver->infog ma48_solve ma48_solve proc~solution_solver->ma48_solve proc~solution_solver->mpi_finalize rhs rhs proc~solution_solver->rhs proc~solv_superlu->interface~destroy_compcol_matrix proc~solv_superlu->interface~destroy_supernode_matrix proc~solv_superlu->interface~dgssvx proc~solv_superlu->interface~statfree proc~solv_superlu->interface~statinit proc~solv_superlu->interface~statprint proc~solv_superlu->proc~prep_superlu proc~solve_syst->proc~analyse_solver proc~solve_syst->proc~close_solver proc~solve_syst->proc~factorize_solver proc~solve_syst->proc~freefact_solver proc~solve_syst->proc~init_solver proc~solve_syst->proc~solution_solver proc~solve_with_pikaia pikaia_class%solve_with_pikaia proc~solve_with_pikaia->proc~pikaia proc~sort_array2->proc~change_array_order proc~sort_array2->proc~init_order proc~sort_array_integer_with_order sort_array_integer_with_order proc~sort_array2->proc~sort_array_integer_with_order proc~sort_array_real_with_order sort_array_real_with_order proc~sort_array2->proc~sort_array_real_with_order proc~sort_array_integer sort_array_integer proc~sort_array_integer->proc~sort_array_integer proc~sort_array_integer_with_order->proc~sort_array_integer_with_order proc~sort_array_real sort_array_real proc~sort_array_real->proc~sort_array_real proc~sort_array_real_with_order->proc~sort_array_real_with_order proc~stdrep->proc~urand proc~str_remove_chars str_remove_chars proc~str_replace str_replace proc~surf2scal->proc~c_f_string proc~unit2iuf unit2IUf proc~surf2scal->proc~unit2iuf proc~tab_alloc_fftw3 tab_alloc_fftw3 proc~tab_alloc_fftw3->interface~fftw_alloc_complex proc~tab_alloc_fftw3_real tab_alloc_fftw3_real proc~tab_alloc_fftw3_real->interface~fftw_alloc_complex proc~tab_alloc_fftw3_real->interface~fftw_alloc_real proc~tab_calc_fftw3 tab_calc_fftw3 proc~tab_calc_fftw3->interface~fftw_execute_dft omp_get_thread_num omp_get_thread_num proc~tab_calc_fftw3->omp_get_thread_num proc~tab_calc_fftw3_real_bwd tab_calc_fftw3_real_bwd proc~tab_calc_fftw3_real_bwd->interface~fftw_execute_dft_c2r proc~tab_calc_fftw3_real_bwd->omp_get_thread_num proc~tab_calc_fftw3_real_fwd tab_calc_fftw3_real_fwd proc~tab_calc_fftw3_real_fwd->interface~fftw_execute_dft_r2c proc~tab_calc_fftw3_real_fwd->omp_get_thread_num proc~tab_desalloc_fftw3 tab_desalloc_fftw3 proc~tab_desalloc_fftw3->interface~fftw_free proc~tab_destroy_plan_fftw3 tab_destroy_plan_fftw3 proc~tab_destroy_plan_fftw3->interface~fftw_destroy_plan proc~tab_end_fftw3 tab_end_fftw3 proc~tab_end_fftw3->proc~tab_desalloc_fftw3 proc~tab_end_fftw3->proc~tab_destroy_plan_fftw3 proc~tab_end_fftw3_real tab_end_fftw3_real proc~tab_end_fftw3_real->proc~tab_desalloc_fftw3 proc~tab_end_fftw3_real->proc~tab_destroy_plan_fftw3 proc~tab_init_fftw3 tab_init_fftw3 proc~tab_init_fftw3->proc~tab_alloc_fftw3 proc~tab_make_plan_fftw3 tab_make_plan_fftw3 proc~tab_init_fftw3->proc~tab_make_plan_fftw3 proc~tab_init_fftw3_real tab_init_fftw3_real proc~tab_init_fftw3_real->proc~tab_alloc_fftw3_real proc~tab_make_plan_fftw3_real tab_make_plan_fftw3_real proc~tab_init_fftw3_real->proc~tab_make_plan_fftw3_real proc~tab_jf_tcheby->omp_get_num_procs proc~tab_make_plan_fftw3->interface~fftw_plan_dft_2d proc~tab_make_plan_fftw3_real->interface~fftw_plan_dft_c2r_2d proc~tab_make_plan_fftw3_real->interface~fftw_plan_dft_r2c_2d proc~tab_poly_tcheby->omp_get_num_procs proc~tab_tcheby->proc~tcheby proc~test01 test01 proc~test01->proc~run_gnuplot proc~write_xy_data write_xy_data proc~test01->proc~write_xy_data proc~write_xy_plot write_xy_plot proc~test01->proc~write_xy_plot proc~test02 test02 proc~test02->proc~run_gnuplot proc~write_xyy_data write_xyy_data proc~test02->proc~write_xyy_data proc~write_xyy_plots write_xyy_plots proc~test02->proc~write_xyy_plots proc~test03 test03 proc~test03->proc~pi proc~test03->proc~run_gnuplot proc~write_xyz_data write_xyz_data proc~test03->proc~write_xyz_data proc~write_xyz_plot write_xyz_plot proc~test03->proc~write_xyz_plot proc~test04 test04 proc~test04->proc~run_gnuplot proc~write_vector_data write_vector_data proc~test04->proc~write_vector_data proc~write_vector_plot write_vector_plot proc~test04->proc~write_vector_plot proc~test05 test05 proc~test05->proc~run_gnuplot proc~write_xyzgrid_data write_xyzgrid_data proc~test05->proc~write_xyzgrid_data proc~write_xyzgrid_surface write_xyzgrid_surface proc~test05->proc~write_xyzgrid_surface proc~test06 test06 proc~test06->proc~run_gnuplot proc~write_xyzgrid_contour write_xyzgrid_contour proc~test06->proc~write_xyzgrid_contour proc~test06->proc~write_xyzgrid_data proc~test_interp_pond test_interp_pond proc~test_interp_pond->proc~def_tab1d proc~test_interp_pond->proc~def_tab2d proc~test_interp_pond->proc~interp1d proc~test_interp_pond->proc~interp2d proc~test_interp_pond->proc~restrict1d proc~test_interp_pond->proc~restrict2d proc~timestamp timestamp proc~timestamp~2 timestamp proc~trans_center2corner trans_center2corner proc~trans_center2corner_cmpl trans_center2corner_cmpl proc~trans_center2corner->proc~trans_center2corner_cmpl proc~trans_center2corner_real trans_center2corner_real proc~trans_center2corner->proc~trans_center2corner_real proc~trans_corner2center trans_corner2center proc~trans_corner2center_cmpl trans_corner2center_cmpl proc~trans_corner2center->proc~trans_corner2center_cmpl proc~trans_corner2center_real trans_corner2center_real proc~trans_corner2center->proc~trans_corner2center_real proc~trans_surf_tab->proc~unit2iuc proc~trans_surf_txt->proc~c_f_string proc~trans_surf_txt->proc~empty proc~trans_surf_txt->proc~get_unit~2 proc~umf4cdef umf4cdef proc~umf4cdef->proc~umfpack_defaults proc~umf4cfnum umf4cfnum proc~umf4cfnum->proc~umfpack_free_numeric proc~umf4cfnum_ip->proc~umfpack_free_numeric proc~umf4cfsym umf4cfsym proc~umf4cfsym->proc~umfpack_free_symbolic proc~umf4cfsym_ip->proc~umfpack_free_symbolic proc~umf4clnum umf4clnum proc~umf4clnum->proc~umfpack_load_numeric proc~umf4clnum_ip->proc~umfpack_load_numeric proc~umf4clsym umf4clsym proc~umf4clsym->proc~umfpack_load_symbolic proc~umf4clsym_ip->proc~umfpack_load_symbolic proc~umf4cnum umf4cnum proc~umf4cnum->interface~s_umfpack_numeric proc~umf4cnum_ip->interface~s_umfpack_numeric proc~umf4cpcon umf4cpcon proc~umf4cpcon->proc~umfpack_report_control proc~umf4cpinf umf4cpinf proc~umf4cpinf->proc~umfpack_report_info proc~umf4cscal umf4cscal proc~umf4cscal->interface~umfpack_scale_function proc~umf4cscal_ip->interface~umfpack_scale_function proc~umf4csnum umf4csnum proc~umf4csnum->proc~umfpack_save_numeric proc~umf4csnum_ip->proc~umfpack_save_numeric proc~umf4csol umf4csol proc~umf4csol->interface~s_umfpack_solve proc~umf4csol_ip->proc~s_umfpack_ci_solve proc~umf4csolr umf4csolr proc~umf4csolr->interface~s_umfpack_solve proc~umf4csolr_ip->interface~s_umfpack_solve proc~umf4cssym umf4cssym proc~umf4cssym->proc~umfpack_save_symbolic proc~umf4cssym_ip->proc~umfpack_save_symbolic proc~umf4csym umf4csym proc~umf4csym->interface~s_umfpack_symbolic proc~umf4csym_ip->interface~s_umfpack_symbolic proc~umf4def umf4def proc~umf4def->proc~umfpack_defaults proc~umf4fnum umf4fnum proc~umf4fnum->proc~umfpack_free_numeric proc~umf4fnum_ip->proc~umfpack_free_numeric proc~umf4fsym umf4fsym proc~umf4fsym->proc~umfpack_free_symbolic proc~umf4fsym_ip->proc~umfpack_free_symbolic proc~umf4lnum umf4lnum proc~umf4lnum->proc~umfpack_load_numeric proc~umf4lnum_ip->proc~umfpack_load_numeric proc~umf4lsym umf4lsym proc~umf4lsym->proc~umfpack_load_symbolic proc~umf4lsym_ip->proc~umfpack_load_symbolic proc~umf4num umf4num proc~umf4num->interface~s_umfpack_numeric proc~umf4num_ip->interface~s_umfpack_numeric proc~umf4pcon umf4pcon proc~umf4pcon->proc~umfpack_report_control proc~umf4pinf umf4pinf proc~umf4pinf->proc~umfpack_report_info proc~umf4scal umf4scal proc~umf4scal->interface~umfpack_scale_function proc~umf4scal_ip->interface~umfpack_scale_function proc~umf4snum umf4snum proc~umf4snum->proc~umfpack_save_numeric proc~umf4snum_ip->proc~umfpack_save_numeric proc~umf4sol umf4sol proc~umf4sol->interface~s_umfpack_solve proc~umf4sol_ip->interface~s_umfpack_solve proc~umf4solr umf4solr proc~umf4solr->interface~s_umfpack_solve proc~umf4solr_ip->interface~s_umfpack_solve proc~umf4ssym umf4ssym proc~umf4ssym->proc~umfpack_save_symbolic proc~umf4ssym_ip->proc~umfpack_save_symbolic proc~umf4sym umf4sym proc~umf4sym->interface~s_umfpack_symbolic proc~umf4sym_ip->interface~s_umfpack_symbolic proc~umf4zdef umf4zdef proc~umf4zdef->proc~umfpack_defaults proc~umf4zfnum umf4zfnum proc~umf4zfnum->proc~umfpack_free_numeric proc~umf4zfnum_ip->proc~umfpack_free_numeric proc~umf4zfsym umf4zfsym proc~umf4zfsym->proc~umfpack_free_symbolic proc~umf4zfsym_ip->proc~umfpack_free_symbolic proc~umf4zlnum umf4zlnum proc~umf4zlnum->proc~umfpack_load_numeric proc~umf4zlnum_ip->proc~umfpack_load_numeric proc~umf4zlsym umf4zlsym proc~umf4zlsym->proc~umfpack_load_symbolic proc~umf4zlsym_ip->proc~umfpack_load_symbolic proc~umf4znum umf4znum proc~umf4znum->interface~s_umfpack_numeric proc~umf4znum_ip->interface~s_umfpack_numeric proc~umf4zpcon umf4zpcon proc~umf4zpcon->proc~umfpack_report_control proc~umf4zpinf umf4zpinf proc~umf4zpinf->proc~umfpack_report_info proc~umf4zscal umf4zscal proc~umf4zscal->interface~umfpack_scale_function proc~umf4zscal_ip->interface~umfpack_scale_function proc~umf4zsnum umf4zsnum proc~umf4zsnum->proc~umfpack_save_numeric proc~umf4zsnum_ip->proc~umfpack_save_numeric proc~umf4zsol umf4zsol proc~umf4zsol->interface~s_umfpack_solve proc~umf4zsol_ip->interface~s_umfpack_zi_solve proc~umf4zsolr umf4zsolr proc~umf4zsolr->interface~s_umfpack_solve proc~umf4zsolr_ip->interface~s_umfpack_solve proc~umf4zssym umf4zssym proc~umf4zssym->proc~umfpack_save_symbolic proc~umf4zssym_ip->proc~umfpack_save_symbolic proc~umf4zsym umf4zsym proc~umf4zsym->interface~s_umfpack_symbolic proc~umf4zsym_ip->interface~s_umfpack_symbolic proc~umfpack_ci_numeric->interface~c_umfpack_zi_numeric proc~umfpack_ci_operator_csc->proc~s_umfpack_ci_numeric proc~umfpack_ci_operator_csc->proc~s_umfpack_ci_solve proc~umfpack_ci_operator_csc->proc~s_umfpack_ci_symbolic proc~umfpack_ci_operator_csc->proc~umfpack_zi_free_numeric proc~umfpack_ci_operator_csc->proc~umfpack_zi_free_symbolic proc~umfpack_ci_operator_csr->proc~s_umfpack_ci_numeric proc~umfpack_ci_operator_csr->proc~s_umfpack_ci_solve proc~umfpack_ci_operator_csr->proc~s_umfpack_ci_symbolic proc~umfpack_ci_operator_csr->proc~umfpack_zi_free_numeric proc~umfpack_ci_operator_csr->proc~umfpack_zi_free_symbolic proc~umfpack_ci_operator_pcsc->proc~s_umfpack_ci_numeric proc~umfpack_ci_operator_pcsc->proc~s_umfpack_ci_solve proc~umfpack_ci_operator_pcsc->proc~s_umfpack_ci_symbolic proc~umfpack_ci_operator_pcsc->proc~umfpack_zi_free_numeric proc~umfpack_ci_operator_pcsc->proc~umfpack_zi_free_symbolic proc~umfpack_ci_operator_pcsr->proc~s_umfpack_ci_numeric proc~umfpack_ci_operator_pcsr->proc~s_umfpack_ci_solve proc~umfpack_ci_operator_pcsr->proc~s_umfpack_ci_symbolic proc~umfpack_ci_operator_pcsr->proc~umfpack_zi_free_numeric proc~umfpack_ci_operator_pcsr->proc~umfpack_zi_free_symbolic proc~umfpack_ci_scale->interface~c_umfpack_zi_scale proc~umfpack_ci_solve->interface~c_umfpack_zi_solve proc~umfpack_ci_symbolic->interface~c_umfpack_zi_symbolic proc~umfpack_defaults->proc~umfpack_di_defaults proc~umfpack_defaults->proc~umfpack_zi_defaults proc~umfpack_di_defaults->interface~c_umfpack_di_defaults proc~umfpack_di_free_numeric->interface~c_umfpack_di_free_numeric proc~umfpack_di_free_symbolic->interface~c_umfpack_di_free_symbolic proc~umfpack_di_load_numeric->interface~c_umfpack_di_load_numeric proc~umfpack_di_load_symbolic->interface~c_umfpack_di_load_symbolic proc~umfpack_di_numeric->interface~c_umfpack_di_numeric proc~umfpack_di_operator_csc->proc~s_umfpack_di_numeric proc~umfpack_di_operator_csc->proc~s_umfpack_di_solve proc~umfpack_di_operator_csc->proc~s_umfpack_di_symbolic proc~umfpack_di_operator_csc->proc~umfpack_di_free_numeric proc~umfpack_di_operator_csc->proc~umfpack_di_free_symbolic proc~umfpack_di_operator_csr->proc~s_umfpack_di_numeric proc~umfpack_di_operator_csr->proc~s_umfpack_di_solve proc~umfpack_di_operator_csr->proc~s_umfpack_di_symbolic proc~umfpack_di_operator_csr->proc~umfpack_di_free_numeric proc~umfpack_di_operator_csr->proc~umfpack_di_free_symbolic proc~umfpack_di_operator_pcsc->proc~s_umfpack_di_numeric proc~umfpack_di_operator_pcsc->proc~s_umfpack_di_solve proc~umfpack_di_operator_pcsc->proc~s_umfpack_di_symbolic proc~umfpack_di_operator_pcsc->proc~umfpack_di_free_numeric proc~umfpack_di_operator_pcsc->proc~umfpack_di_free_symbolic proc~umfpack_di_operator_pcsr->proc~s_umfpack_di_numeric proc~umfpack_di_operator_pcsr->proc~s_umfpack_di_solve proc~umfpack_di_operator_pcsr->proc~s_umfpack_di_symbolic proc~umfpack_di_operator_pcsr->proc~umfpack_di_free_numeric proc~umfpack_di_operator_pcsr->proc~umfpack_di_free_symbolic proc~umfpack_di_report_control->interface~c_umfpack_di_report_control proc~umfpack_di_report_info->interface~c_umfpack_di_report_info proc~umfpack_di_save_numeric->interface~c_umfpack_di_save_numeric proc~umfpack_di_save_symbolic->interface~c_umfpack_di_save_symbolic proc~umfpack_di_scale->interface~c_umfpack_di_scale proc~umfpack_di_solve->interface~c_umfpack_di_solve proc~umfpack_di_symbolic->interface~c_umfpack_di_symbolic proc~umfpack_free_numeric->proc~umfpack_di_free_numeric proc~umfpack_free_numeric->proc~umfpack_zi_free_numeric proc~umfpack_free_symbolic->proc~umfpack_di_free_symbolic proc~umfpack_free_symbolic->proc~umfpack_zi_free_symbolic proc~umfpack_load_numeric->proc~umfpack_di_load_numeric proc~umfpack_load_numeric->proc~umfpack_zi_load_numeric proc~umfpack_load_symbolic->proc~umfpack_di_load_symbolic proc~umfpack_load_symbolic->proc~umfpack_zi_load_symbolic proc~umfpack_report_control->proc~umfpack_di_report_control proc~umfpack_report_control->proc~umfpack_zi_report_control proc~umfpack_report_info->proc~umfpack_di_report_info proc~umfpack_report_info->proc~umfpack_zi_report_info proc~umfpack_save_numeric->proc~umfpack_di_save_numeric proc~umfpack_save_numeric->proc~umfpack_zi_save_numeric proc~umfpack_save_symbolic->proc~umfpack_di_save_symbolic proc~umfpack_save_symbolic->proc~umfpack_zi_save_symbolic proc~umfpack_zi_defaults->interface~c_umfpack_zi_defaults proc~umfpack_zi_free_numeric->interface~c_umfpack_zi_free_numeric proc~umfpack_zi_free_symbolic->interface~c_umfpack_zi_free_symbolic proc~umfpack_zi_load_numeric->interface~c_umfpack_zi_load_numeric proc~umfpack_zi_load_symbolic->interface~c_umfpack_zi_load_symbolic proc~umfpack_zi_numeric umfpack_zi_numeric proc~umfpack_zi_numeric->interface~c_umfpack_zi_numeric proc~umfpack_zi_operator_csc->interface~s_umfpack_zi_numeric proc~umfpack_zi_operator_csc->interface~s_umfpack_zi_solve proc~umfpack_zi_operator_csc->interface~s_umfpack_zi_symbolic proc~umfpack_zi_operator_csc->proc~umfpack_zi_free_numeric proc~umfpack_zi_operator_csc->proc~umfpack_zi_free_symbolic proc~umfpack_zi_operator_csr->interface~s_umfpack_zi_numeric proc~umfpack_zi_operator_csr->interface~s_umfpack_zi_solve proc~umfpack_zi_operator_csr->interface~s_umfpack_zi_symbolic proc~umfpack_zi_operator_csr->proc~umfpack_zi_free_numeric proc~umfpack_zi_operator_csr->proc~umfpack_zi_free_symbolic proc~umfpack_zi_operator_pcsc->interface~s_umfpack_zi_numeric proc~umfpack_zi_operator_pcsc->interface~s_umfpack_zi_solve proc~umfpack_zi_operator_pcsc->interface~s_umfpack_zi_symbolic proc~umfpack_zi_operator_pcsc->proc~umfpack_zi_free_numeric proc~umfpack_zi_operator_pcsc->proc~umfpack_zi_free_symbolic proc~umfpack_zi_operator_pcsr->interface~s_umfpack_zi_numeric proc~umfpack_zi_operator_pcsr->interface~s_umfpack_zi_solve proc~umfpack_zi_operator_pcsr->interface~s_umfpack_zi_symbolic proc~umfpack_zi_operator_pcsr->proc~umfpack_zi_free_numeric proc~umfpack_zi_operator_pcsr->proc~umfpack_zi_free_symbolic proc~umfpack_zi_report_control->interface~c_umfpack_zi_report_control proc~umfpack_zi_report_info->interface~c_umfpack_zi_report_info proc~umfpack_zi_save_numeric->interface~c_umfpack_zi_save_numeric proc~umfpack_zi_save_symbolic->interface~c_umfpack_zi_save_symbolic proc~umfpack_zi_scale umfpack_zi_scale proc~umfpack_zi_scale->interface~c_umfpack_zi_scale proc~umfpack_zi_solve umfpack_zi_solve proc~umfpack_zi_solve->interface~c_umfpack_zi_solve proc~umfpack_zi_symbolic umfpack_zi_symbolic proc~umfpack_zi_symbolic->interface~c_umfpack_zi_symbolic proc~unit2iuc->proc~unit2iuf proc~urand->proc~genrand64_real1 proc~vec2path vec2path proc~vec2path->proc~dir_separator proc~verif_solution verif_solution proc~verif_solution->proc~prod_a_x proc~verif_solution->proc~prod_elemental_x proc~write_polar_data write_polar_data proc~write_polar_data->proc~get_unit proc~write_polar_plot write_polar_plot proc~write_polar_plot->proc~get_unit proc~write_surf write_surf proc~write_surf->proc~build_surf proc~write_surf->proc~get_unit~2 proc~write_surf->proc~lower proc~write_surf->proc~scal2surf proc~write_surf->proc~surf2scal proc~write_surffile write_surffile proc~write_surf->proc~write_surffile proc~write_surffile->proc~get_unit~2 proc~write_vector_data->proc~get_unit proc~write_vector_plot->proc~get_unit proc~write_xy2_data write_xy2_data proc~write_xy2_data->proc~get_unit proc~write_xy2_plot write_xy2_plot proc~write_xy2_plot->proc~get_unit proc~write_xy_data->proc~get_unit proc~write_xy_plot->proc~get_unit proc~write_xyy_data->proc~get_unit proc~write_xyy_plots->proc~get_unit proc~write_xyz_data->proc~get_unit proc~write_xyz_plot->proc~get_unit proc~write_xyzgrid_contour->proc~get_unit proc~write_xyzgrid_data->proc~get_unit proc~write_xyzgrid_surface->proc~get_unit proc~write_y_plot write_y_plot proc~write_y_plot->proc~get_unit program~main main program~main->proc~get_unit~2 program~main->proc~init_order program~main->proc~sort_array2 program~test_algen test_algen program~test_algen->proc~abs_diff_sk_ku program~test_algen->proc~get_unit~2 program~test_algen->proc~melange program~test_algen->proc~newton_raphson_downhill program~test_algen->proc~profil_theo_trie_1d program~test_algen->proc~set_inputs program~test_algen->proc~solve_with_pikaia program~test_bspline test_bspline program~test_bspline->proc~interp_surf program~test_data_arch test_data_arch program~test_data_arch->proc~get_unit~2 program~test_data_arch->proc~progress_bar_terminal program~test_data_arch->proc~trans_center2corner program~test_data_arch->proc~trans_corner2center program~test_fftw3 test_fftw3 program~test_fftw3->interface~fftw_plan_with_nthreads program~test_fftw3->proc~calc_fftw3 program~test_fftw3->proc~calc_fftw3_real_bwd program~test_fftw3->proc~calc_fftw3_real_fwd program~test_fftw3->proc~end_fftw3 program~test_fftw3->proc~get_unit~2 program~test_fftw3->proc~init_fftw3 program~test_fftw3->proc~init_fftw3_real program~test_fftw3->proc~read_surf program~test_fftw3->proc~save_surf program~test_fftw3->proc~tab_calc_fftw3 program~test_fftw3->proc~tab_calc_fftw3_real_bwd program~test_fftw3->proc~tab_calc_fftw3_real_fwd program~test_fftw3->proc~tab_end_fftw3 program~test_fftw3->proc~tab_end_fftw3_real program~test_fftw3->proc~tab_init_fftw3 program~test_fftw3->proc~tab_init_fftw3_real omp_get_max_threads omp_get_max_threads program~test_fftw3->omp_get_max_threads program~test_files test_files program~test_files->proc~dir_separator program~test_files->proc~filename program~test_files->proc~list_files program~test_files->proc~make_path program~test_files->proc~mkdir program~test_files->proc~path2vec program~test_files->proc~str_remove_chars program~test_files->proc~str_replace program~test_files->proc~vec2path program~test_gnufor test_gnufor program~test_gnufor->proc~test01 program~test_gnufor->proc~test02 program~test_gnufor->proc~test03 program~test_gnufor->proc~test04 program~test_gnufor->proc~test05 program~test_gnufor->proc~test06 program~test_intpl test_intpl program~test_intpl->proc~test_interp_pond program~test_least test_least program~test_least->proc~calc_imp_acf program~test_least->proc~calc_jf program~test_least->proc~moindres_carres program~test_least->proc~moindres_carres_lineaire program~test_minpack test_minpack program~test_minpack->proc~chkder_test program~test_minpack->proc~hybrd1_test program~test_minpack->proc~hybrj1_test program~test_minpack->proc~lmder1_2_test program~test_minpack->proc~lmder1_test program~test_minpack->proc~lmdif1_2_test program~test_minpack->proc~lmdif1_test program~test_minpack->proc~lmstr1_2_test program~test_minpack->proc~lmstr1_test program~test_minpack->proc~qform_test program~test_minpack->proc~timestamp program~test_solvers test_solvers program~test_solvers->proc~convert_matrice_format program~test_solvers->proc~get_unit~2 program~test_solvers->proc~modify_a_elt program~test_solvers->proc~solve_syst program~test_solvers->proc~verif_solution omp_get_wtime omp_get_wtime program~test_solvers->omp_get_wtime program~test_surfile test_surfile program~test_surfile->proc~init_scal program~test_surfile->proc~read_surf~2 program~test_surfile->proc~scal2surf program~test_surfile->proc~trans_surf_txt program~test_surfile->proc~write_surf program~test_tchebychev test_tchebychev program~test_tchebychev->proc~convert_to_poly program~test_tchebychev->proc~genere_surf_poly program~test_tchebychev->proc~get_unit~2 program~test_tchebychev->proc~least_squares_tcheby program~test_utils test_utils program~test_utils->proc~choldc program~test_utils->proc~cholsl
Help