Skip to content

AFNI/NIfTI Server

Sections
Personal tools
You are here: Home » AFNI » Documentation

Doxygen Source Code Documentation


Main Page   Alphabetical List   Data Structures   File List   Data Fields   Globals   Search  

estpdf3.c File Reference

#include "pdf.h"
#include "randgen.c"
#include "pdf.c"
#include "Simplexx.c"

Go to the source code of this file.


Defines

#define quiet   0
#define DIMENSION   9

Functions

float calc_error (float *vertex)
void estpdf_short_initialize (int nxyz, short *sfim, float *gpeak, float *wpeak)
void estpdf_float_initialize (int nxyz, float *ffim, int nbin, float *gpeak, float *wpeak)
void generate_initial_guess (float gpeak, float wpeak, float *parameters)
void write_parameter_vector (float *parameters)
float normal (float x, float mean, float sigma)
float estimate (float *parameters, float x)
void output_pdf_results (float *vertex, float sse)
void estpdf_short (int nxyz, short *sfim, float *parameters)
void estpdf_float (int nxyz, float *ffim, int nbin, float *parameters)

Variables

pdf p

Define Documentation

#define DIMENSION   9
 

Definition at line 46 of file estpdf3.c.

Referenced by write_parameter_vector().

#define quiet   0
 

Definition at line 27 of file estpdf3.c.

Referenced by estpdf_float(), estpdf_float_initialize(), estpdf_short(), estpdf_short_initialize(), and output_pdf_results().


Function Documentation

float calc_error float *    vertex
 

Definition at line 332 of file estpdf3.c.

References BIG_NUMBER, estimate(), i, pdf::lower_bnd, pdf::nbin, PDF_ibin_to_xvalue(), pdf::prob, pdf::upper_bnd, and pdf::width.

Referenced by restart(), simplex_initialize(), and simplex_optimization().

00334 {
00335   const float BIG_NUMBER = 1.0e+10;  /* return when constraints are violated */
00336 
00337   float b, bmean, bsigma, g, gmean, gsigma, w, wmean, wsigma;  /* parameters */
00338   float deltah, deltam;          /* rough estimate of spread of distribution */
00339 
00340   int i;
00341   float t;
00342   float diff, sse;
00343 
00344   count += 1;
00345 
00346 
00347   /*----- Assign local variables -----*/
00348   b      = vertex[0];
00349   bmean  = vertex[1];
00350   bsigma = vertex[2];
00351   g      = vertex[3];
00352   gmean  = vertex[4];
00353   gsigma = vertex[5];
00354   w      = vertex[6];
00355   wmean  = vertex[7];
00356   wsigma = vertex[8];
00357 
00358   deltah = p.upper_bnd - p.lower_bnd;
00359   deltam = wmean - gmean;
00360 
00361 
00362   /*----- Apply constraints? -----*/
00363   if ((b < 0.05) || (b > 1.5))          return (BIG_NUMBER);
00364   if ((g < 0.05) || (g > 1.0))          return (BIG_NUMBER);
00365   if ((w < 0.05) || (w > 1.0))          return (BIG_NUMBER);
00366   if ((b+g+w < 1.0) || (b+g+w > 2.0))   return (BIG_NUMBER);
00367 
00368   if ((bmean < p.lower_bnd) || (bmean > p.upper_bnd))  return (BIG_NUMBER);
00369   if ((gmean < p.lower_bnd) || (gmean > p.upper_bnd))  return (BIG_NUMBER);
00370   if ((wmean < p.lower_bnd) || (wmean > p.upper_bnd))  return (BIG_NUMBER);
00371   if ((gmean < bmean)    || (gmean > wmean))     return (BIG_NUMBER);
00372 
00373   if ((gmean-bmean) < 0.10*(wmean-bmean))        return (BIG_NUMBER);
00374   if ((wmean-gmean) < 0.10*(wmean-bmean))        return (BIG_NUMBER);
00375 
00376   if ((bsigma < 0.01*deltah) || (bsigma > 0.5*deltah))  return (BIG_NUMBER);
00377   if ((gsigma < 0.01*deltam) || (gsigma > 0.5*deltam))  return (BIG_NUMBER);
00378   if ((wsigma < 0.01*deltam) || (wsigma > 0.5*deltam))  return (BIG_NUMBER);
00379 
00380 
00381   /*----- Not constrained, so calculate actual error sum of squares -----*/
00382   sse = 0.0;
00383 
00384   for (i = 0;  i < p.nbin;  i++)
00385     {
00386       t = PDF_ibin_to_xvalue (p, i);
00387       diff = p.prob[i] - estimate (vertex, t)*p.width;
00388       sse += diff * diff;
00389     }
00390 
00391   
00392   return (sse);
00393 }

float estimate float *    parameters,
float    x
 

Definition at line 297 of file estpdf3.c.

References normal().

Referenced by calc_error(), and calc_sse().

00299 {
00300   float b, bmean, bsigma, g, gmean, gsigma, w, wmean, wsigma;
00301   float z, fval;
00302 
00303 
00304   /*----- Initialize local variables -----*/
00305   b      = parameters[0];
00306   bmean  = parameters[1];
00307   bsigma = parameters[2];
00308   g      = parameters[3];
00309   gmean  = parameters[4];
00310   gsigma = parameters[5];
00311   w      = parameters[6];
00312   wmean  = parameters[7];
00313   wsigma = parameters[8];
00314 
00315 
00316   /*----- Calculate the sum of three normal PDF's -----*/ 
00317   fval  = b * normal (x, bmean, bsigma);
00318   fval += g * normal (x, gmean, gsigma);
00319   fval += w * normal (x, wmean, wsigma);
00320 
00321 
00322   return (fval);
00323   
00324 }

void estpdf_float int    nxyz,
float *    ffim,
int    nbin,
float *    parameters
 

Definition at line 480 of file estpdf3.c.

References estpdf_float_initialize(), generate_initial_guess(), gpeak, output_pdf_results(), quiet, simplex_optimization(), and wpeak.

Referenced by estimate_field().

00481 {
00482   float gpeak;               /* estimated peak of gray-matter distribution */
00483   float wpeak;               /* estimated peak of white-matter distribution */
00484   float sse;
00485 
00486 
00487   /*----- Progress report -----*/
00488   if( !quiet )
00489    printf ("\nEstimating PDF of voxel intensities \n");
00490 
00491   
00492   /*----- Initialization for PDF estimation -----*/
00493   estpdf_float_initialize (nxyz, ffim, nbin, &gpeak, &wpeak);
00494 
00495 
00496   /*----- Make initial estimate of the parameters from previous results -----*/
00497   generate_initial_guess (gpeak, wpeak, parameters);
00498  
00499 
00500   /*----- Get least squares estimate for PDF parameters -----*/
00501   simplex_optimization (parameters, &sse);
00502 
00503 
00504   /*----- Report PDF parameters -----*/
00505   output_pdf_results (parameters, sse);
00506 
00507 
00508   /*----- Free memory -----*/
00509   /*
00510   PDF_destroy (&p);
00511   */
00512  
00513   return ;
00514 }

void estpdf_float_initialize int    nxyz,
float *    ffim,
int    nbin,
float *    gpeak,
float *    wpeak
 

Definition at line 136 of file estpdf3.c.

References gpeak, pdf::lower_bnd, PDF_copy(), PDF_destroy(), PDF_find_bimodal(), PDF_float_to_pdf(), PDF_ibin_to_xvalue(), PDF_initialize(), PDF_smooth(), PDF_sprint(), PDF_trim(), quiet, pdf::upper_bnd, wmax, and wpeak.

Referenced by estpdf_float().

00144 {
00145   pdf ps;
00146   int gmax, wmax;
00147   int kk;
00148   int ok = 1;
00149 
00150 
00151   /*---- Initialize pdf's -----*/
00152   PDF_initialize (&p);
00153   PDF_initialize (&ps);
00154 
00155 
00156   /*----- Convert float array to pdf estimate -----*/
00157   PDF_float_to_pdf (nxyz, ffim, nbin, &p);
00158   PDF_sprint ("\nOriginal PDF:", p);
00159 
00160 
00161   /*----- Trim extreme values from pdf estimate -----*/
00162   PDF_trim (0.01, 0.99, &p);
00163   PDF_sprint ("\nTrimmed PDF:", p);
00164 
00165 
00166   /*----- Smooth the pdf estimate -----*/
00167   PDF_copy (p, &ps);
00168   PDF_smooth (&ps);
00169   PDF_sprint ("\nSmoothed PDF:", ps);
00170 
00171 
00172   /*----- Try to locate bimodality of the pdf -----*/
00173   ok = PDF_find_bimodal (ps, &gmax, &wmax);
00174   if (ok)
00175     {
00176       *gpeak = PDF_ibin_to_xvalue (ps, gmax);
00177       *wpeak = PDF_ibin_to_xvalue (ps, wmax);
00178     }
00179   else
00180     {
00181       printf ("Unable to find bimodal distribution \n");
00182       *gpeak = (2.0/3.0)*p.lower_bnd + (1.0/3.0)*p.upper_bnd;
00183       *wpeak = (1.0/3.0)*p.lower_bnd + (2.0/3.0)*p.upper_bnd;
00184     }
00185 
00186 
00187   if( !quiet ){
00188     printf ("\nInitial PDF estimates: \n");
00189     printf ("Lower Bnd = %8.3f   Upper Bnd  = %8.3f \n", 
00190             p.lower_bnd, p.upper_bnd);
00191     printf ("Gray Peak = %8.3f   White Peak = %8.3f \n", *gpeak, *wpeak);
00192   }
00193 
00194 
00195   PDF_destroy (&ps);
00196 
00197 }

void estpdf_short int    nxyz,
short *    sfim,
float *    parameters
 

Definition at line 439 of file estpdf3.c.

References estpdf_short_initialize(), generate_initial_guess(), gpeak, output_pdf_results(), quiet, simplex_optimization(), and wpeak.

Referenced by initialize_program().

00440 {
00441   float gpeak;               /* estimated peak of gray-matter distribution */
00442   float wpeak;               /* estimated peak of white-matter distribution */
00443   float sse;
00444 
00445 
00446   /*----- Progress report -----*/
00447   if( !quiet )
00448    printf ("\nEstimating PDF of voxel intensities \n");
00449 
00450   
00451   /*----- Initialization for PDF estimation -----*/
00452   estpdf_short_initialize (nxyz, sfim, &gpeak, &wpeak);
00453 
00454 
00455   generate_initial_guess (gpeak, wpeak, parameters);
00456  
00457 
00458   /*----- Get least squares estimate for PDF parameters -----*/
00459   simplex_optimization (parameters, &sse);
00460 
00461 
00462   /*----- Report PDF parameters -----*/
00463   output_pdf_results (parameters, sse);
00464 
00465 
00466   /*----- Free memory -----*/
00467   /*
00468   PDF_destroy (&p);
00469   */
00470 
00471   return;
00472 }

void estpdf_short_initialize int    nxyz,
short *    sfim,
float *    gpeak,
float *    wpeak
 

Definition at line 67 of file estpdf3.c.

References gpeak, pdf::lower_bnd, PDF_copy(), PDF_destroy(), PDF_find_bimodal(), PDF_ibin_to_xvalue(), PDF_initialize(), PDF_short_to_pdf(), PDF_smooth(), PDF_sprint(), PDF_trim(), quiet, pdf::upper_bnd, wmax, and wpeak.

Referenced by estpdf_short().

00074 {
00075   pdf ps;
00076   int gmax, wmax;
00077   int kk;
00078   int ok = 1;
00079 
00080 
00081   /*---- Initialize pdf's -----*/
00082   PDF_initialize (&p);
00083   PDF_initialize (&ps);
00084 
00085 
00086   /*----- Convert short array to pdf estimate -----*/
00087   PDF_short_to_pdf (nxyz, sfim, &p);
00088   PDF_sprint ("\nOriginal PDF:", p);
00089 
00090 
00091   /*----- Trim extreme values from pdf estimate -----*/
00092   PDF_trim (0.01, 0.99, &p);
00093   PDF_sprint ("\nTrimmed PDF:", p);
00094 
00095 
00096   /*----- Smooth the pdf estimate -----*/
00097   PDF_copy (p, &ps);
00098   PDF_smooth (&ps);
00099   PDF_sprint ("\nSmoothed PDF:", ps);
00100 
00101 
00102   /*----- Try to locate bimodality of the pdf -----*/
00103   ok = PDF_find_bimodal (ps, &gmax, &wmax);
00104   if (ok)
00105     {
00106       *gpeak = PDF_ibin_to_xvalue (ps, gmax);
00107       *wpeak = PDF_ibin_to_xvalue (ps, wmax);
00108     }
00109   else
00110     {
00111       printf ("Unable to find bimodal distribution \n");
00112       *gpeak = (2.0/3.0)*p.lower_bnd + (1.0/3.0)*p.upper_bnd;
00113       *wpeak = (1.0/3.0)*p.lower_bnd + (2.0/3.0)*p.upper_bnd;
00114     }
00115 
00116 
00117   if( !quiet ){
00118    printf ("\nInitial PDF estimates: \n");
00119    printf ("Lower Bnd = %8.3f   Upper Bnd  = %8.3f \n", 
00120            p.lower_bnd, p.upper_bnd);
00121    printf ("Gray Peak = %8.3f   White Peak = %8.3f \n", *gpeak, *wpeak);
00122   }
00123 
00124 
00125   PDF_destroy (&ps);
00126 
00127 }

void generate_initial_guess float    gpeak,
float    wpeak,
float *    parameters
 

Definition at line 205 of file estpdf3.c.

References gpeak, pdf::lower_bnd, pdf::upper_bnd, and wpeak.

Referenced by estpdf(), estpdf_float(), and estpdf_short().

00206 {
00207   float b;                   /* coefficient for background distribution */
00208   float bmean;               /* mean for background distribution */ 
00209   float bsigma;              /* std. dev. for background distribution */
00210   float g;                   /* coefficient for gray-matter distribution */
00211   float gmean;               /* mean for gray-matter distribution */
00212   float gsigma;              /* std. dev. for gray-matter distribution */
00213   float w;                   /* coefficient for white-matter distribution */
00214   float wmean;               /* mean for white-matter distribution */
00215   float wsigma;              /* std. dev. for white-matter distribution */
00216 
00217 
00218   /*----- Initialize distribution coefficients -----*/
00219   b = 0.75;
00220   g = 0.25;
00221   w = 0.25;
00222 
00223 
00224   /*----- Initialize distribution means -----*/
00225   bmean = p.lower_bnd;
00226 
00227   if ((gpeak > p.lower_bnd) && (gpeak < p.upper_bnd) && (gpeak < wpeak)) 
00228     gmean = gpeak;
00229   else
00230     gmean = p.lower_bnd;
00231 
00232   if ((wpeak > p.lower_bnd) && (wpeak < p.upper_bnd) && (wpeak > gpeak))
00233     wmean = wpeak;
00234   else
00235     wmean = p.upper_bnd;
00236 
00237   if ((gmean-bmean) < 0.25*(wmean-bmean))  gmean = bmean + 0.25*(wmean-bmean);
00238   if ((wmean-gmean) < 0.25*(wmean-bmean))  gmean = wmean - 0.25*(wmean-bmean);
00239 
00240 
00241   /*----- Initialize distribution standard deviations -----*/
00242   bsigma = 0.25 * (p.upper_bnd - p.lower_bnd);
00243   gsigma = 0.25 * (wmean - gmean);
00244   wsigma = 0.25 * (wmean - gmean);
00245 
00246 
00247   /*----- Set parameter vector -----*/
00248   parameters[0] = b;
00249   parameters[1] = bmean;
00250   parameters[2] = bsigma;
00251   parameters[3] = g;
00252   parameters[4] = gmean;
00253   parameters[5] = gsigma;
00254   parameters[6] = w;
00255   parameters[7] = wmean;
00256   parameters[8] = wsigma;
00257 
00258 }

float normal float    x,
float    mean,
float    sigma
 

Definition at line 281 of file estpdf3.c.

00283 {
00284   float z;
00285 
00286   z = (x - mean) / sigma;
00287 
00288   return ( (1.0/(sqrt(2.0*PI)*sigma)) * exp (-0.5 * z * z) );
00289 }

void output_pdf_results float *    vertex,
float    sse
 

Definition at line 401 of file estpdf3.c.

References pdf::nbin, and quiet.

Referenced by estpdf(), estpdf_float(), and estpdf_short().

00402 {
00403   float b, bmean, bsigma, g, gmean, gsigma, w, wmean, wsigma;
00404 
00405 
00406   /*----- Assign variables -----*/
00407   b      = vertex[0];
00408   bmean  = vertex[1];
00409   bsigma = vertex[2];
00410   g      = vertex[3];
00411   gmean  = vertex[4];
00412   gsigma = vertex[5];
00413   w      = vertex[6];
00414   wmean  = vertex[7];
00415   wsigma = vertex[8];
00416 
00417   if( !quiet ){
00418    printf ("\nProbability Density Function Estimates: \n");
00419    printf ("Background Coef      = %f \n", b);
00420    printf ("Background Mean      = %f \n", bmean);
00421    printf ("Background Std Dev   = %f \n", bsigma);
00422    printf ("Gray Matter Coef     = %f \n", g);
00423    printf ("Gray Matter Mean     = %f \n", gmean);
00424    printf ("Gray Matter Std Dev  = %f \n", gsigma);
00425    printf ("White Matter Coef    = %f \n", w);
00426    printf ("White Matter Mean    = %f \n", wmean);
00427    printf ("White Matter Std Dev = %f \n", wsigma);
00428    printf ("\nrmse = %f \n", sqrt (sse / p.nbin ));
00429   }
00430 
00431 }

void write_parameter_vector float *    parameters
 

Definition at line 266 of file estpdf3.c.

References DIMENSION, and i.

00267 {
00268   int i;
00269 
00270   printf ("Dimension = %d \n", DIMENSION);
00271   for (i = 0;  i < DIMENSION;  i++)
00272     printf ("parameter[%d] = %f \n", i, parameters[i]);
00273 }

Variable Documentation

pdf p
 

Definition at line 48 of file estpdf3.c.

Referenced by _dl_search_paths(), aawalk(), afwalk(), all_mappable_surfs(), alloc_output_mem(), allocate_memory(), allocate_pieces(), analyze_results(), argsort(), attack_files(), bang(), beta_p2t(), beta_t2p(), betadf(), bfrac(), bgrat(), binomial_p2t(), binomial_t2p(), bisect_(), c_get(), c_sfe(), calc_constraints(), calc_flof(), calc_freg(), calc_full_model(), calc_matrices(), calc_partial_derivatives(), calc_sse(), calc_tcoef(), calculate_results(), cdfbet(), cdfbin(), cdfchi(), cdfchn(), cdff(), cdffnc(), cdfgam(), cdfnbn(), cdfnor(), cdfpoi(), cdft(), check_for_valid_inputs(), check_im_byte_order(), check_norm_dirs(), check_one_volume(), check_outfile(), check_temporary_files(), chisq_p2t(), chisq_t2p(), clear_around_point(), clf(), clset_(), comblock(), compare(), complete_orients_str(), compute_face_vols(), compute_node_areas(), compute_node_vols(), compute_results(), copy_surfaces(), copyData(), count_volumes_and_files(), create_gert_dicom(), create_gert_script(), create_node(), crossprod(), csfft_nextup(), cumnor(), dataval(), DCM_ElementDictionary(), DCM_GetElementValue(), DCM_GetElementValueList(), DCM_GetElementValueOffset(), DCM_ListToString(), DCM_LookupElement(), DCM_ParseObject(), DCM_ScanParseObject(), debug_free(), debug_free_id(), debug_malloc_id(), debug_realloc(), debug_realloc_id(), dicom_order_files(), dinvnr(), disp_numeric_data(), disp_param_data(), disp_param_t(), disp_v2s_param_t(), dlerror(), dmalloc_info(), docomleng(), doentry(), DRAW_value_CB(), dt1(), dtree_delete_coords(), dtree_insert_at_node(), dtree_position(), dtree_unlink_node(), dump_surf_3dt(), E0001(), e_d(), endioctl(), erf1(), erfc1(), estimate_field(), excall(), exelif(), exif(), exportData(), exportFixedFields(), exportVRLength(), f_init(), f_inqu(), fail_die_malloc(), fail_die_realloc(), file_block_getter(), fill_node_list(), final_clean_up(), final_cleanup(), find_first_volume(), find_fl_file_index(), find_more_volumes(), find_next_zoff(), free(), freetemps(), frtemp(), fstat_p2t(), fstat_t2p(), fstat_t2pp(), gam1(), gaminv(), gamma_p2t(), gamma_t2p(), generate_ts_array(), get_argtypes(), get_cmask(), get_inputs(), get_options(), get_surf_data(), get_surf_measures(), getcd(), getcds(), gettok(), glob2(), globextend(), glt_analysis(), grat1(), hashclear(), hashkey(), hexcheck(), hidden_NI_malloc(), hookup(), hqr2_(), hqr_(), identify_repeats(), idisp_hf_param_t(), idisp_param_t(), idisp_xhair_pts(), imagpart(), imtql1_(), imtql2_(), imtqlv_(), incbeta(), incbeta_inverse(), init_delay(), init_extras(), init_indep_var_matrix(), init_node_list(), init_options(), init_regression_analysis(), init_seg_endpoints(), initialize(), initialize_filters(), initialize_options(), initialize_program(), initialize_signal_model(), initialize_simplex(), InitSpline(), insert_list(), insert_newest(), insertNewElement(), intdouble(), isort_double(), isort_doubleint(), isort_float(), isort_floatfloat(), isort_floatint(), isort_floatstuff(), isort_int(), isort_intint(), ISORT_NAME(), isort_pair(), isort_sh(), isort_short(), jpeg_gen_optimal_table(), jpeg_make_c_derived_tbl(), jpeg_make_d_derived_tbl(), krput(), l_CHAR(), Lagrange_interp(), lencat(), lnbeta(), lwrt_A(), lwrt_I(), magnitude_f(), main(), malloc(), matrix_extract(), matrix_extract_rows(), matrix_inverse(), mcw_XtFree(), mcw_XtRealloc(), median_float5(), median_float7(), median_float9(), mkaddcon(), mkbitcon(), mkconst(), mkcxcon(), mkintcon(), mklogcon(), mkrealcon(), mkstrcon(), mktmpn(), mri_dicom_header(), myMalloc(), ncat(), ne_d(), newentry(), nextdata(), NI_free(), nlfit(), normal_p2t(), normal_t2p(), NSMakePrivateModulePublic(), output_parameters(), output_results(), paintSubMenuArrow(), PARSER_set_printout(), pcalc(), PDF_copy(), PDF_create(), PDF_destroy(), PDF_ibin_to_xvalue(), PDF_initialize(), PDF_normalize(), PDF_xvalue_to_ibin(), poisson_p2t(), poisson_t2p(), poly_field(), popinclude(), pow_ci(), pow_zi(), print_column_headers(), process_file(), process_ge(), process_ge4(), ps_prolog(), punwrap(), putaddr(), putcall(), putcat(), putch1(), putchcmp(), putcheq(), putchop(), putconst(), putcx1(), putcxcmp(), putcxeq(), putcxop(), putexpr(), putif(), putmnmx(), putop(), putout(), putpower(), putwhile(), putx(), pythag_(), qginv(), qginv_(), qh_printhyperplaneintersection(), qh_printpoint3(), r_index2pt(), r_init_pt_conn_s(), RAN_setup(), random_search(), ratqr_(), RCREND_rotmatrix(), rd_A(), rd_AW(), rd_F(), read_ge_files(), read_input_data(), read_nodes_file(), read_surf_files(), read_sxyz_1D(), realloc(), realpart(), record_block_getter(), regression_analysis(), REND_rotmatrix(), report_results(), restart(), retval(), rfft(), rgb_to_XImage_clever(), rot_matrix(), rot_to_matrix(), rot_to_shear(), rot_to_shear_matvec(), rotmatrix(), RWC_destroy_nullify(), RWC_destroy_nullify_cancel(), RWC_destroy_nullify_CB(), s2v_nodes2volume(), save_parameters(), save_results(), save_voxel(), saveargtypes(), scan_ge_files(), sdata_from_1D(), set_node_list_data(), set_params(), set_smap_opts(), set_surf_results(), set_unusuality_tail(), set_URL_progress(), set_volume_stats(), show_point_list_s(), simplex_optimization(), stinv(), stree_extract_max(), stree_insert(), stvaln(), suma2afni_surf(), SUMA_cb_search_text(), SUMA_Chung_Smooth_Weights(), SUMA_dPoint_At_Distance(), SUMA_GetVoxelsIntersectingTriangle(), SUMA_Help_Cmap_destroyed(), SUMA_Help_Cmap_open(), SUMA_Help_destroyed(), SUMA_Help_open(), SUMA_isinpoly(), SUMA_isNumString(), SUMA_isSelfIntersect(), SUMA_Message_destroyed(), SUMA_Message_open(), SUMA_Point_At_Distance(), SUMA_SumaInfo_destroyed(), SUMA_SumaInfo_open(), SUMA_SurfGridIntersect(), SUMA_SurfInfo_destroyed(), SUMA_SurfInfo_open(), SUMA_ViewerInfo_destroyed(), SUMA_ViewerInfo_open(), SUMA_writeSpecFile(), surf_triangle_match(), sxyz_1D_to_nlist(), teapot(), terminate_program(), THD_matrix_to_orientation(), threshold_data(), tinvit_(), tql1_(), tql2_(), tqlrat_(), tridib_(), tsturm_(), UTL_ConvertTimetoFloat(), UTL_VerifyCreatePath(), validate_datasets(), validate_option_lists(), validate_options(), validate_surface(), validate_v2s_inputs(), verify_parser_expr(), verify_surf_t(), verifyFormat(), vertex_load(), vol2surf(), volume_match(), volume_search(), warper_affine_for(), warper_affine_inv(), warper_bilinear_for(), warper_bilinear_inv(), warper_shift_for(), warper_shift_inv(), wavelet_analysis(), write_bucket_data(), write_data_to_file(), write_output(), write_parameters(), write_typedefs(), wrt_A(), wrt_AW(), wrt_G(), Xgamm(), and yyparse().

 

Powered by Plone

This site conforms to the following standards: