ROL
Public Member Functions | List of all members
ROL::SandiaRules Class Reference

#include <ROL_SandiaRules.hpp>

+ Inheritance diagram for ROL::SandiaRules:

Public Member Functions

 SandiaRules (void)
 
void binary_vector_next (int n, int bvec[])
 
void ccn_compute (int n, double x[], double w[])
 
void ccn_compute_np (int n, int np, double p[], double x[], double w[])
 
void ccn_compute_points (int n, double x[])
 
void ccn_compute_points_np (int n, int np, double p[], double x[])
 
void ccn_compute_weights (int n, double w[])
 
void ccn_compute_weights_np (int n, int np, double p[], double w[])
 
void chebyshev1_compute (int order, double x[], double w[])
 
void chebyshev1_compute_np (int order, int np, double p[], double x[], double w[])
 
void chebyshev1_compute_points (int order, double x[])
 
void chebyshev1_compute_points_np (int order, int np, double p[], double x[])
 
void chebyshev1_compute_weights (int order, double w[])
 
void chebyshev1_compute_weights_np (int order, int np, double p[], double w[])
 
double chebyshev1_integral (int expon)
 
void chebyshev2_compute (int order, double x[], double w[])
 
void chebyshev2_compute_np (int order, int np, double p[], double x[], double w[])
 
void chebyshev2_compute_points (int order, double x[])
 
void chebyshev2_compute_points_np (int order, int np, double p[], double x[])
 
void chebyshev2_compute_weights (int order, double w[])
 
void chebyshev2_compute_weights_np (int order, int np, double p[], double w[])
 
double chebyshev2_integral (int expon)
 
void clenshaw_curtis_compute (int order, double x[], double w[])
 
void clenshaw_curtis_compute_np (int order, int np, double p[], double x[], double w[])
 
void clenshaw_curtis_compute_points (int order, double x[])
 
void clenshaw_curtis_compute_points_np (int order, int np, double p[], double x[])
 
void clenshaw_curtis_compute_weights (int order, double w[])
 
void clenshaw_curtis_compute_weights_np (int order, int np, double p[], double w[])
 
void comp_next (int n, int k, int a[], bool *more, int *h, int *t)
 
double cpu_time ()
 
void dif_deriv (int nd, double xd[], double yd[], int *ndp, double xdp[], double ydp[])
 
void dif_shift_x (int nd, double xd[], double yd[], double xv)
 
void dif_shift_zero (int nd, double xd[], double yd[])
 
void dif_to_r8poly (int nd, double xd[], double yd[], double c[])
 
void fejer2_compute (int order, double x[], double w[])
 
void fejer2_compute_np (int order, int np, double p[], double x[], double w[])
 
void fejer2_compute_points (int order, double x[])
 
void fejer2_compute_points_np (int order, int np, double p[], double x[])
 
void fejer2_compute_weights (int order, double w[])
 
void fejer2_compute_weights_np (int order, int np, double p[], double w[])
 
void gegenbauer_compute (int order, double alpha, double x[], double w[])
 
void gegenbauer_compute_np (int order, int np, double p[], double x[], double w[])
 
void gegenbauer_compute_points (int order, double alpha, double x[])
 
void gegenbauer_compute_points_np (int order, int np, double p[], double x[])
 
void gegenbauer_compute_weights (int order, double alpha, double w[])
 
void gegenbauer_compute_weights_np (int order, int np, double p[], double w[])
 
double gegenbauer_integral (int expon, double alpha)
 
void gegenbauer_recur (double *p2, double *dp2, double *p1, double x, int order, double alpha, double c[])
 
void gegenbauer_root (double *x, int order, double alpha, double *dp2, double *p1, double c[])
 
void gen_hermite_compute (int order, double alpha, double x[], double w[])
 
void gen_hermite_compute_np (int order, int np, double p[], double x[], double w[])
 
void gen_hermite_compute_points (int order, double alpha, double x[])
 
void gen_hermite_compute_points_np (int order, int np, double p[], double x[])
 
void gen_hermite_compute_weights (int order, double alpha, double w[])
 
void gen_hermite_compute_weights_np (int order, int np, double p[], double w[])
 
void gen_hermite_dr_compute (int order, double alpha, double x[], double w[])
 
double gen_hermite_integral (int expon, double alpha)
 
void gen_laguerre_compute (int order, double alpha, double x[], double w[])
 
void gen_laguerre_compute_np (int order, int np, double p[], double x[], double w[])
 
void gen_laguerre_compute_points (int order, double alpha, double x[])
 
void gen_laguerre_compute_points_np (int order, int np, double p[], double x[])
 
void gen_laguerre_compute_weights (int order, double alpha, double w[])
 
void gen_laguerre_compute_weights_np (int order, int np, double p[], double w[])
 
double gen_laguerre_integral (int expon, double alpha)
 
void gen_laguerre_ss_compute (int order, double alpha, double x[], double w[])
 
void gen_laguerre_ss_recur (double *p2, double *dp2, double *p1, double x, int order, double alpha, double b[], double c[])
 
void gen_laguerre_ss_root (double *x, int order, double alpha, double *dp2, double *p1, double b[], double c[])
 
void hc_compute_weights_from_points (int nhalf, double x[], double w[])
 
void hcc_compute (int n, double x[], double w[])
 
void hcc_compute_np (int n, int np, double p[], double x[], double w[])
 
void hcc_compute_points (int n, double x[])
 
void hcc_compute_points_np (int n, int np, double p[], double x[])
 
void hcc_compute_weights (int n, double w[])
 
void hcc_compute_weights_np (int n, int np, double p[], double w[])
 
void hce_compute (int n, double x[], double w[])
 
void hce_compute_np (int n, int np, double p[], double x[], double w[])
 
void hce_compute_points (int n, double x[])
 
void hce_compute_points_np (int n, int np, double p[], double x[])
 
void hce_compute_weights (int n, double w[])
 
void hce_compute_weights_np (int n, int np, double p[], double w[])
 
void hermite_compute (int order, double x[], double w[])
 
void hermite_compute_np (int order, int np, double p[], double x[], double w[])
 
void hermite_compute_points (int order, double x[])
 
void hermite_compute_points_np (int order, int np, double p[], double x[])
 
void hermite_compute_weights (int order, double w[])
 
void hermite_compute_weights_np (int order, int np, double p[], double w[])
 
void hermite_genz_keister_lookup (int n, double x[], double w[])
 
void hermite_genz_keister_lookup_points (int n, double x[])
 
void hermite_genz_keister_lookup_points_np (int n, int np, double p[], double x[])
 
void hermite_genz_keister_lookup_weights (int n, double w[])
 
void hermite_genz_keister_lookup_weights_np (int n, int np, double p[], double w[])
 
void hermite_gk18_lookup_points (int n, double x[])
 
void hermite_gk22_lookup_points (int n, double x[])
 
void hermite_gk24_lookup_points (int n, double x[])
 
double hermite_integral (int n)
 
void hermite_interpolant (int n, double x[], double y[], double yp[], double xd[], double yd[], double xdp[], double ydp[])
 
void hermite_interpolant_rule (int n, double a, double b, double x[], double w[])
 
void hermite_interpolant_value (int nd, double xd[], double yd[], double xdp[], double ydp[], int nv, double xv[], double yv[], double yvp[])
 
void hermite_lookup (int n, double x[], double w[])
 
void hermite_lookup_points (int n, double x[])
 
void hermite_lookup_weights (int n, double w[])
 
void hermite_ss_compute (int order, double x[], double w[])
 
void hermite_ss_recur (double *p2, double *dp2, double *p1, double x, int order)
 
void hermite_ss_root (double *x, int order, double *dp2, double *p1)
 
int i4_choose (int n, int k)
 
int i4_log_2 (int i)
 
int i4_max (int i1, int i2)
 
int i4_min (int i1, int i2)
 
int i4_power (int i, int j)
 
void i4mat_copy (int m, int n, int a1[], int a2[])
 
int * i4mat_copy_new (int m, int n, int a1[])
 
void i4mat_transpose_print (int m, int n, int a[], std::string title)
 
void i4mat_transpose_print_some (int m, int n, int a[], int ilo, int jlo, int ihi, int jhi, std::string title)
 
void i4mat_write (std::string output_filename, int m, int n, int table[])
 
int * i4vec_add_new (int n, int a[], int b[])
 
bool i4vec_any_lt (int n, int a[], int b[])
 
void i4vec_copy (int n, int a1[], int a2[])
 
int * i4vec_copy_new (int n, int a1[])
 
void i4vec_min_mv (int m, int n, int u[], int v[], int w[])
 
void i4vec_print (int n, int a[], std::string title)
 
int i4vec_product (int n, int a[])
 
int i4vec_sum (int n, int a[])
 
void i4vec_zero (int n, int a[])
 
int * i4vec_zero_new (int n)
 
void imtqlx (int n, double d[], double e[], double z[])
 
void jacobi_compute (int order, double alpha, double beta, double x[], double w[])
 
void jacobi_compute_np (int order, int np, double p[], double x[], double w[])
 
void jacobi_compute_points (int order, double alpha, double beta, double x[])
 
void jacobi_compute_points_np (int order, int np, double p[], double x[])
 
void jacobi_compute_weights (int order, double alpha, double beta, double w[])
 
void jacobi_compute_weights_np (int order, int np, double p[], double w[])
 
double jacobi_integral (int expon, double alpha, double beta)
 
void jacobi_ss_compute (int order, double alpha, double beta, double x[], double w[])
 
void jacobi_ss_recur (double *p2, double *dp2, double *p1, double x, int order, double alpha, double beta, double b[], double c[])
 
void jacobi_ss_root (double *x, int order, double alpha, double beta, double *dp2, double *p1, double b[], double c[])
 
void laguerre_compute (int n, double x[], double w[])
 
void laguerre_compute_np (int order, int np, double p[], double x[], double w[])
 
void laguerre_compute_points (int order, double x[])
 
void laguerre_compute_points_np (int order, int np, double p[], double x[])
 
void laguerre_compute_weights (int order, double w[])
 
void laguerre_compute_weights_np (int order, int np, double p[], double w[])
 
double laguerre_integral (int expon)
 
void laguerre_lookup (int n, double x[], double w[])
 
void laguerre_lookup_points (int n, double x[])
 
void laguerre_lookup_weights (int n, double w[])
 
void laguerre_ss_compute (int order, double x[], double w[])
 
void laguerre_ss_recur (double *p2, double *dp2, double *p1, double x, int order, double b[], double c[])
 
void laguerre_ss_root (double *x, int order, double *dp2, double *p1, double b[], double c[])
 
void legendre_compute (int n, double x[], double w[])
 
void legendre_compute_np (int order, int np, double p[], double x[], double w[])
 
void legendre_compute_points (int order, double x[])
 
void legendre_compute_points_np (int order, int np, double p[], double x[])
 
void legendre_compute_weights (int order, double w[])
 
void legendre_compute_weights_np (int order, int np, double p[], double w[])
 
void legendre_dr_compute (int order, double x[], double w[])
 
double legendre_integral (int expon)
 
void legendre_lookup (int n, double x[], double w[])
 
void legendre_lookup_points (int n, double x[])
 
void legendre_lookup_weights (int n, double w[])
 
double * legendre_zeros (int order)
 
void level_growth_to_order (int dim_num, int level[], int rule[], int growth[], int order[])
 
void level_to_order_default (int dim_num, int level[], int rule[], int order[])
 
void level_to_order_exponential (int dim_num, int level[], int rule[], int order[])
 
void level_to_order_exponential_slow (int dim_num, int level[], int rule[], int order[])
 
void level_to_order_linear (int dim_num, int level[], int rule[], int order[])
 
int level_to_order_exp_cc (int level, int growth)
 
int level_to_order_exp_f2 (int level, int growth)
 
int level_to_order_exp_gauss (int level, int growth)
 
int level_to_order_exp_gp (int level, int growth)
 
int level_to_order_exp_hgk (int level, int growth)
 
int level_to_order_linear_nn (int level, int growth)
 
int level_to_order_linear_wn (int level, int growth)
 
void nc_compute (int n, double x_min, double x_max, double x[], double w[])
 
double * nc_compute_new (int n, double x_min, double x_max, double x[])
 
void ncc_compute_points (int n, double x[])
 
void ncc_compute_weights (int n, double w[])
 
void nco_compute_points (int n, double x[])
 
void nco_compute_weights (int n, double w[])
 
void ncoh_compute_points (int n, double x[])
 
void ncoh_compute_weights (int n, double w[])
 
void patterson_lookup (int n, double x[], double w[])
 
void patterson_lookup_points (int n, double x[])
 
void patterson_lookup_points_np (int n, int np, double p[], double x[])
 
void patterson_lookup_weights (int n, double w[])
 
void patterson_lookup_weights_np (int n, int np, double p[], double w[])
 
int point_radial_tol_unique_count (int m, int n, double a[], double tol, int *seed)
 
void point_radial_tol_unique_count_inc1 (int m, int n1, double a1[], double tol, int *seed, double z[], double r1[], int indx1[], bool unique1[], int *unique_num1)
 
void point_radial_tol_unique_count_inc2 (int m, int n1, double a1[], int n2, double a2[], double tol, double z[], double r1[], int indx1[], bool unique1[], int *unique_num2)
 
int point_radial_tol_unique_index (int m, int n, double a[], double tol, int *seed, int undx[], int xdnu[])
 
void point_radial_tol_unique_index_inc1 (int m, int n1, double a1[], double tol, int *seed, double z[], double r1[], int indx1[], bool unique1[], int *unique_num1, int undx1[], int xdnu1[])
 
void point_radial_tol_unique_index_inc2 (int m, int n1, double a1[], int n2, double a2[], double tol, double z[], double r1[], int indx1[], bool unique1[], int unique_num1, int undx1[], int xdnu1[], double r2[], int indx2[], bool unique2[], int *unique_num2, int undx2[], int xdnu2[])
 
void point_radial_tol_unique_index_inc3 (int m, int n1, double a1[], double r1[], int indx1[], bool unique1[], int unique_num1, int undx1[], int xdnu1[], int n2, double a2[], double r2[], int indx2[], bool unique2[], int unique_num2, int undx2[], int xdnu2[], int *n3, double a3[], double r3[], int indx3[], bool unique3[], int *unique_num3, int undx3[], int xdnu3[])
 
void point_unique_index (int m, int n, double a[], int unique_num, int undx[], int xdnu[])
 
void product_mixed_weight (int dim_num, int order_1d[], int order_nd, int rule[], double alpha[], double beta[], double weight_nd[])
 
double r8_abs (double x)
 
double r8_ceiling (double x)
 
double r8_choose (int n, int k)
 
double r8_epsilon ()
 
double r8_factorial (int n)
 
double r8_factorial2 (int n)
 
double r8_floor (double x)
 
double r8_gamma (double x)
 
double r8_huge ()
 
double r8_hyper_2f1 (double a, double b, double c, double x)
 
double r8_max (double x, double y)
 
double r8_min (double x, double y)
 
double r8_mop (int i)
 
double r8_psi (double xx)
 
double r8_sign (double x)
 
int r8col_compare (int m, int n, double a[], int i, int j)
 
void r8col_sort_heap_a (int m, int n, double a[])
 
int * r8col_sort_heap_index_a (int m, int n, double a[])
 
int r8col_sorted_unique_count (int m, int n, double a[], double tol)
 
void r8col_swap (int m, int n, double a[], int j1, int j2)
 
void r8col_tol_undex (int x_dim, int x_num, double x_val[], int x_unique_num, double tol, int undx[], int xdnu[])
 
int r8col_tol_unique_count (int m, int n, double a[], double tol)
 
void r8col_undex (int x_dim, int x_num, double x_val[], int x_unique_num, double tol, int undx[], int xdnu[])
 
void r8col_unique_index (int m, int n, double a[], double tol, int unique_index[])
 
void r8mat_transpose_print (int m, int n, double a[], std::string title)
 
void r8mat_transpose_print_some (int m, int n, double a[], int ilo, int jlo, int ihi, int jhi, std::string title)
 
void r8mat_write (std::string output_filename, int m, int n, double table[])
 
double r8poly_ant_val (int n, double poly_cof[], double xval)
 
double * r8vec_chebyshev_new (int n, double a_first, double a_last)
 
int r8vec_compare (int n, double a[], double b[])
 
void r8vec_copy (int n, double a1[], double a2[])
 
double * r8vec_copy_new (int n, double a1[])
 
double r8vec_diff_norm_li (int n, double a[], double b[])
 
void r8vec_direct_product2 (int factor_index, int factor_order, double factor_value[], int factor_num, int point_num, double w[])
 
double r8vec_dot_product (int n, double a1[], double a2[])
 
double r8vec_i4vec_dot_product (int n, double r8vec[], int i4vec[])
 
void r8vec_index_sorted_range (int n, double r[], int indx[], double r_lo, double r_hi, int *i_lo, int *i_hi)
 
void r8vec_indexed_heap_d (int n, double a[], int indx[])
 
int r8vec_indexed_heap_d_extract (int *n, double a[], int indx[])
 
void r8vec_indexed_heap_d_insert (int *n, double a[], int indx[], int indx_insert)
 
int r8vec_indexed_heap_d_max (int n, double a[], int indx[])
 
double * r8vec_legendre_new (int n, double a_first, double a_last)
 
double * r8vec_linspace_new (int n, double a_first, double a_last)
 
double r8vec_min (int n, double r8vec[])
 
double r8vec_min_pos (int n, double a[])
 
void r8vec_print (int n, double a[], std::string title)
 
void r8vec_scale (double s, int n, double a[])
 
void r8vec_sort_heap_index_a (int n, double a[], int indx[])
 
int * r8vec_sort_heap_index_a_new (int n, double a[])
 
void r8vec_stutter (int n, double a[], int m, double am[])
 
double r8vec_sum (int n, double a[])
 
void r8vec_uniform_01 (int n, int *seed, double r[])
 
double * r8vec_uniform_01_new (int n, int *seed)
 
void r8vec_zero (int n, double a[])
 
void sort_heap_external (int n, int *indx, int *i, int *j, int isgn)
 
void timestamp ()
 
void vec_colex_next3 (int dim_num, int base[], int a[], bool *more)
 

Detailed Description

Definition at line 58 of file ROL_SandiaRules.hpp.

Constructor & Destructor Documentation

ROL::SandiaRules::SandiaRules ( void  )
inline

Definition at line 61 of file ROL_SandiaRules.hpp.

Member Function Documentation

void ROL::SandiaRules::binary_vector_next ( int  n,
int  bvec[] 
)

Definition at line 48 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::ccn_compute ( int  n,
double  x[],
double  w[] 
)

Definition at line 130 of file ROL_SandiaRulesDef.hpp.

References ccn_compute_points(), and ccn_compute_weights().

void ROL::SandiaRules::ccn_compute_np ( int  n,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 167 of file ROL_SandiaRulesDef.hpp.

References ccn_compute_points(), and ccn_compute_weights().

void ROL::SandiaRules::ccn_compute_points ( int  n,
double  x[] 
)
void ROL::SandiaRules::ccn_compute_points_np ( int  n,
int  np,
double  p[],
double  x[] 
)

Definition at line 326 of file ROL_SandiaRulesDef.hpp.

References ccn_compute_points().

void ROL::SandiaRules::ccn_compute_weights ( int  n,
double  w[] 
)
void ROL::SandiaRules::ccn_compute_weights_np ( int  n,
int  np,
double  p[],
double  w[] 
)

Definition at line 411 of file ROL_SandiaRulesDef.hpp.

References ccn_compute_weights().

void ROL::SandiaRules::chebyshev1_compute ( int  order,
double  x[],
double  w[] 
)

Definition at line 448 of file ROL_SandiaRulesDef.hpp.

Referenced by chebyshev1_compute_np().

void ROL::SandiaRules::chebyshev1_compute_np ( int  order,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 526 of file ROL_SandiaRulesDef.hpp.

References chebyshev1_compute().

void ROL::SandiaRules::chebyshev1_compute_points ( int  order,
double  x[] 
)

Definition at line 586 of file ROL_SandiaRulesDef.hpp.

Referenced by chebyshev1_compute_points_np().

void ROL::SandiaRules::chebyshev1_compute_points_np ( int  order,
int  np,
double  p[],
double  x[] 
)

Definition at line 648 of file ROL_SandiaRulesDef.hpp.

References chebyshev1_compute_points().

void ROL::SandiaRules::chebyshev1_compute_weights ( int  order,
double  w[] 
)

Definition at line 695 of file ROL_SandiaRulesDef.hpp.

Referenced by chebyshev1_compute_weights_np().

void ROL::SandiaRules::chebyshev1_compute_weights_np ( int  order,
int  np,
double  p[],
double  w[] 
)

Definition at line 752 of file ROL_SandiaRulesDef.hpp.

References chebyshev1_compute_weights().

double ROL::SandiaRules::chebyshev1_integral ( int  expon)

Definition at line 799 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::chebyshev2_compute ( int  order,
double  x[],
double  w[] 
)

Definition at line 861 of file ROL_SandiaRulesDef.hpp.

Referenced by chebyshev2_compute_np().

void ROL::SandiaRules::chebyshev2_compute_np ( int  order,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 938 of file ROL_SandiaRulesDef.hpp.

References chebyshev2_compute().

void ROL::SandiaRules::chebyshev2_compute_points ( int  order,
double  x[] 
)

Definition at line 998 of file ROL_SandiaRulesDef.hpp.

Referenced by chebyshev2_compute_points_np().

void ROL::SandiaRules::chebyshev2_compute_points_np ( int  order,
int  np,
double  p[],
double  x[] 
)

Definition at line 1062 of file ROL_SandiaRulesDef.hpp.

References chebyshev2_compute_points().

void ROL::SandiaRules::chebyshev2_compute_weights ( int  order,
double  w[] 
)

Definition at line 1109 of file ROL_SandiaRulesDef.hpp.

Referenced by chebyshev2_compute_weights_np().

void ROL::SandiaRules::chebyshev2_compute_weights_np ( int  order,
int  np,
double  p[],
double  w[] 
)

Definition at line 1168 of file ROL_SandiaRulesDef.hpp.

References chebyshev2_compute_weights().

double ROL::SandiaRules::chebyshev2_integral ( int  expon)

Definition at line 1215 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::clenshaw_curtis_compute ( int  order,
double  x[],
double  w[] 
)

Definition at line 1278 of file ROL_SandiaRulesDef.hpp.

Referenced by clenshaw_curtis_compute_np().

void ROL::SandiaRules::clenshaw_curtis_compute_np ( int  order,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 1384 of file ROL_SandiaRulesDef.hpp.

References clenshaw_curtis_compute().

void ROL::SandiaRules::clenshaw_curtis_compute_points ( int  order,
double  x[] 
)
void ROL::SandiaRules::clenshaw_curtis_compute_points_np ( int  order,
int  np,
double  p[],
double  x[] 
)

Definition at line 1500 of file ROL_SandiaRulesDef.hpp.

References clenshaw_curtis_compute_points().

void ROL::SandiaRules::clenshaw_curtis_compute_weights ( int  order,
double  w[] 
)
void ROL::SandiaRules::clenshaw_curtis_compute_weights_np ( int  order,
int  np,
double  p[],
double  w[] 
)

Definition at line 1633 of file ROL_SandiaRulesDef.hpp.

References clenshaw_curtis_compute_weights().

void ROL::SandiaRules::comp_next ( int  n,
int  k,
int  a[],
bool *  more,
int *  h,
int *  t 
)

Definition at line 1682 of file ROL_SandiaRulesDef.hpp.

double ROL::SandiaRules::cpu_time ( )

Definition at line 1823 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::dif_deriv ( int  nd,
double  xd[],
double  yd[],
int *  ndp,
double  xdp[],
double  ydp[] 
)

Definition at line 1856 of file ROL_SandiaRulesDef.hpp.

References dif_shift_zero().

Referenced by hermite_interpolant().

void ROL::SandiaRules::dif_shift_x ( int  nd,
double  xd[],
double  yd[],
double  xv 
)

Definition at line 1945 of file ROL_SandiaRulesDef.hpp.

Referenced by dif_shift_zero().

void ROL::SandiaRules::dif_shift_zero ( int  nd,
double  xd[],
double  yd[] 
)

Definition at line 2027 of file ROL_SandiaRulesDef.hpp.

References dif_shift_x().

Referenced by dif_deriv().

void ROL::SandiaRules::dif_to_r8poly ( int  nd,
double  xd[],
double  yd[],
double  c[] 
)

Definition at line 2091 of file ROL_SandiaRulesDef.hpp.

Referenced by hermite_interpolant_rule().

void ROL::SandiaRules::fejer2_compute ( int  order,
double  x[],
double  w[] 
)

Definition at line 2155 of file ROL_SandiaRulesDef.hpp.

Referenced by fejer2_compute_np().

void ROL::SandiaRules::fejer2_compute_np ( int  order,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 2252 of file ROL_SandiaRulesDef.hpp.

References fejer2_compute().

void ROL::SandiaRules::fejer2_compute_points ( int  order,
double  x[] 
)

Definition at line 2298 of file ROL_SandiaRulesDef.hpp.

Referenced by fejer2_compute_points_np().

void ROL::SandiaRules::fejer2_compute_points_np ( int  order,
int  np,
double  p[],
double  x[] 
)

Definition at line 2362 of file ROL_SandiaRulesDef.hpp.

References fejer2_compute_points().

void ROL::SandiaRules::fejer2_compute_weights ( int  order,
double  w[] 
)

Definition at line 2406 of file ROL_SandiaRulesDef.hpp.

Referenced by fejer2_compute_weights_np(), and product_mixed_weight().

void ROL::SandiaRules::fejer2_compute_weights_np ( int  order,
int  np,
double  p[],
double  w[] 
)

Definition at line 2504 of file ROL_SandiaRulesDef.hpp.

References fejer2_compute_weights().

void ROL::SandiaRules::gegenbauer_compute ( int  order,
double  alpha,
double  x[],
double  w[] 
)
void ROL::SandiaRules::gegenbauer_compute_np ( int  order,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 2776 of file ROL_SandiaRulesDef.hpp.

References gegenbauer_compute().

void ROL::SandiaRules::gegenbauer_compute_points ( int  order,
double  alpha,
double  x[] 
)

Definition at line 2842 of file ROL_SandiaRulesDef.hpp.

References gegenbauer_compute().

Referenced by gegenbauer_compute_points_np().

void ROL::SandiaRules::gegenbauer_compute_points_np ( int  order,
int  np,
double  p[],
double  x[] 
)

Definition at line 2891 of file ROL_SandiaRulesDef.hpp.

References gegenbauer_compute_points().

void ROL::SandiaRules::gegenbauer_compute_weights ( int  order,
double  alpha,
double  w[] 
)

Definition at line 2941 of file ROL_SandiaRulesDef.hpp.

References gegenbauer_compute().

Referenced by gegenbauer_compute_weights_np().

void ROL::SandiaRules::gegenbauer_compute_weights_np ( int  order,
int  np,
double  p[],
double  w[] 
)

Definition at line 2990 of file ROL_SandiaRulesDef.hpp.

References gegenbauer_compute_weights().

double ROL::SandiaRules::gegenbauer_integral ( int  expon,
double  alpha 
)

Definition at line 3038 of file ROL_SandiaRulesDef.hpp.

References r8_gamma(), and r8_hyper_2f1().

void ROL::SandiaRules::gegenbauer_recur ( double *  p2,
double *  dp2,
double *  p1,
double  x,
int  order,
double  alpha,
double  c[] 
)

Definition at line 3102 of file ROL_SandiaRulesDef.hpp.

Referenced by gegenbauer_root().

void ROL::SandiaRules::gegenbauer_root ( double *  x,
int  order,
double  alpha,
double *  dp2,
double *  p1,
double  c[] 
)

Definition at line 3173 of file ROL_SandiaRulesDef.hpp.

References gegenbauer_recur(), r8_abs(), and r8_epsilon().

Referenced by gegenbauer_compute().

void ROL::SandiaRules::gen_hermite_compute ( int  order,
double  alpha,
double  x[],
double  w[] 
)
void ROL::SandiaRules::gen_hermite_compute_np ( int  order,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 3351 of file ROL_SandiaRulesDef.hpp.

References gen_hermite_compute().

void ROL::SandiaRules::gen_hermite_compute_points ( int  order,
double  alpha,
double  x[] 
)
void ROL::SandiaRules::gen_hermite_compute_points_np ( int  order,
int  np,
double  p[],
double  x[] 
)

Definition at line 3454 of file ROL_SandiaRulesDef.hpp.

References gen_hermite_compute_points().

void ROL::SandiaRules::gen_hermite_compute_weights ( int  order,
double  alpha,
double  w[] 
)
void ROL::SandiaRules::gen_hermite_compute_weights_np ( int  order,
int  np,
double  p[],
double  w[] 
)

Definition at line 3538 of file ROL_SandiaRulesDef.hpp.

References gen_hermite_compute_weights().

void ROL::SandiaRules::gen_hermite_dr_compute ( int  order,
double  alpha,
double  x[],
double  w[] 
)

Definition at line 3581 of file ROL_SandiaRulesDef.hpp.

References gen_laguerre_ss_compute(), and r8_gamma().

double ROL::SandiaRules::gen_hermite_integral ( int  expon,
double  alpha 
)

Definition at line 3723 of file ROL_SandiaRulesDef.hpp.

References r8_gamma(), and r8_huge().

void ROL::SandiaRules::gen_laguerre_compute ( int  order,
double  alpha,
double  x[],
double  w[] 
)
void ROL::SandiaRules::gen_laguerre_compute_np ( int  order,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 3889 of file ROL_SandiaRulesDef.hpp.

References gen_laguerre_compute().

void ROL::SandiaRules::gen_laguerre_compute_points ( int  order,
double  alpha,
double  x[] 
)
void ROL::SandiaRules::gen_laguerre_compute_points_np ( int  order,
int  np,
double  p[],
double  x[] 
)

Definition at line 4023 of file ROL_SandiaRulesDef.hpp.

References gen_laguerre_compute_points().

void ROL::SandiaRules::gen_laguerre_compute_weights ( int  order,
double  alpha,
double  w[] 
)
void ROL::SandiaRules::gen_laguerre_compute_weights_np ( int  order,
int  np,
double  p[],
double  w[] 
)

Definition at line 4111 of file ROL_SandiaRulesDef.hpp.

References gen_laguerre_compute_weights().

double ROL::SandiaRules::gen_laguerre_integral ( int  expon,
double  alpha 
)

Definition at line 4156 of file ROL_SandiaRulesDef.hpp.

References r8_gamma().

void ROL::SandiaRules::gen_laguerre_ss_compute ( int  order,
double  alpha,
double  x[],
double  w[] 
)

Definition at line 4201 of file ROL_SandiaRulesDef.hpp.

References gen_laguerre_ss_root(), and r8_gamma().

Referenced by gen_hermite_dr_compute().

void ROL::SandiaRules::gen_laguerre_ss_recur ( double *  p2,
double *  dp2,
double *  p1,
double  x,
int  order,
double  alpha,
double  b[],
double  c[] 
)

Definition at line 4366 of file ROL_SandiaRulesDef.hpp.

Referenced by gen_laguerre_ss_root().

void ROL::SandiaRules::gen_laguerre_ss_root ( double *  x,
int  order,
double  alpha,
double *  dp2,
double *  p1,
double  b[],
double  c[] 
)

Definition at line 4440 of file ROL_SandiaRulesDef.hpp.

References gen_laguerre_ss_recur(), r8_abs(), and r8_epsilon().

Referenced by gen_laguerre_ss_compute().

void ROL::SandiaRules::hc_compute_weights_from_points ( int  nhalf,
double  x[],
double  w[] 
)
void ROL::SandiaRules::hcc_compute ( int  n,
double  x[],
double  w[] 
)
void ROL::SandiaRules::hcc_compute_np ( int  n,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 4629 of file ROL_SandiaRulesDef.hpp.

References hcc_compute().

void ROL::SandiaRules::hcc_compute_points ( int  n,
double  x[] 
)
void ROL::SandiaRules::hcc_compute_points_np ( int  n,
int  np,
double  p[],
double  x[] 
)

Definition at line 4739 of file ROL_SandiaRulesDef.hpp.

References hcc_compute_points().

void ROL::SandiaRules::hcc_compute_weights ( int  n,
double  w[] 
)
void ROL::SandiaRules::hcc_compute_weights_np ( int  n,
int  np,
double  p[],
double  w[] 
)

Definition at line 4845 of file ROL_SandiaRulesDef.hpp.

References hcc_compute_weights().

void ROL::SandiaRules::hce_compute ( int  n,
double  x[],
double  w[] 
)
void ROL::SandiaRules::hce_compute_np ( int  n,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 4952 of file ROL_SandiaRulesDef.hpp.

References hce_compute().

void ROL::SandiaRules::hce_compute_points ( int  n,
double  x[] 
)
void ROL::SandiaRules::hce_compute_points_np ( int  n,
int  np,
double  p[],
double  x[] 
)

Definition at line 5065 of file ROL_SandiaRulesDef.hpp.

References hce_compute_points().

void ROL::SandiaRules::hce_compute_weights ( int  n,
double  w[] 
)
void ROL::SandiaRules::hce_compute_weights_np ( int  n,
int  np,
double  p[],
double  w[] 
)

Definition at line 5171 of file ROL_SandiaRulesDef.hpp.

References hce_compute_weights().

void ROL::SandiaRules::hermite_compute ( int  order,
double  x[],
double  w[] 
)
void ROL::SandiaRules::hermite_compute_np ( int  order,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 5315 of file ROL_SandiaRulesDef.hpp.

References hermite_compute().

void ROL::SandiaRules::hermite_compute_points ( int  order,
double  x[] 
)
void ROL::SandiaRules::hermite_compute_points_np ( int  order,
int  np,
double  p[],
double  x[] 
)

Definition at line 5415 of file ROL_SandiaRulesDef.hpp.

References hermite_compute_points().

void ROL::SandiaRules::hermite_compute_weights ( int  order,
double  w[] 
)
void ROL::SandiaRules::hermite_compute_weights_np ( int  order,
int  np,
double  p[],
double  w[] 
)

Definition at line 5491 of file ROL_SandiaRulesDef.hpp.

References hermite_compute_weights().

void ROL::SandiaRules::hermite_genz_keister_lookup ( int  n,
double  x[],
double  w[] 
)
void ROL::SandiaRules::hermite_genz_keister_lookup_points ( int  n,
double  x[] 
)
void ROL::SandiaRules::hermite_genz_keister_lookup_points_np ( int  n,
int  np,
double  p[],
double  x[] 
)

Definition at line 5902 of file ROL_SandiaRulesDef.hpp.

References hermite_genz_keister_lookup_points().

void ROL::SandiaRules::hermite_genz_keister_lookup_weights ( int  n,
double  w[] 
)
void ROL::SandiaRules::hermite_genz_keister_lookup_weights_np ( int  n,
int  np,
double  p[],
double  w[] 
)

Definition at line 6282 of file ROL_SandiaRulesDef.hpp.

References hermite_genz_keister_lookup_weights().

void ROL::SandiaRules::hermite_gk18_lookup_points ( int  n,
double  x[] 
)

Definition at line 6358 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::hermite_gk22_lookup_points ( int  n,
double  x[] 
)

Definition at line 6520 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::hermite_gk24_lookup_points ( int  n,
double  x[] 
)

Definition at line 6681 of file ROL_SandiaRulesDef.hpp.

double ROL::SandiaRules::hermite_integral ( int  n)

Definition at line 6844 of file ROL_SandiaRulesDef.hpp.

References r8_factorial2(), and r8_huge().

void ROL::SandiaRules::hermite_interpolant ( int  n,
double  x[],
double  y[],
double  yp[],
double  xd[],
double  yd[],
double  xdp[],
double  ydp[] 
)

Definition at line 6901 of file ROL_SandiaRulesDef.hpp.

References dif_deriv().

Referenced by hermite_interpolant_rule().

void ROL::SandiaRules::hermite_interpolant_rule ( int  n,
double  a,
double  b,
double  x[],
double  w[] 
)

Definition at line 6997 of file ROL_SandiaRulesDef.hpp.

References dif_to_r8poly(), hermite_interpolant(), and r8poly_ant_val().

void ROL::SandiaRules::hermite_interpolant_value ( int  nd,
double  xd[],
double  yd[],
double  xdp[],
double  ydp[],
int  nv,
double  xv[],
double  yv[],
double  yvp[] 
)

Definition at line 7099 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::hermite_lookup ( int  n,
double  x[],
double  w[] 
)

Definition at line 7175 of file ROL_SandiaRulesDef.hpp.

References hermite_lookup_points(), and hermite_lookup_weights().

void ROL::SandiaRules::hermite_lookup_points ( int  n,
double  x[] 
)

Definition at line 7246 of file ROL_SandiaRulesDef.hpp.

Referenced by hermite_lookup().

void ROL::SandiaRules::hermite_lookup_weights ( int  n,
double  w[] 
)

Definition at line 7605 of file ROL_SandiaRulesDef.hpp.

Referenced by hermite_lookup().

void ROL::SandiaRules::hermite_ss_compute ( int  order,
double  x[],
double  w[] 
)

Definition at line 7964 of file ROL_SandiaRulesDef.hpp.

References hermite_ss_root(), and r8_gamma().

void ROL::SandiaRules::hermite_ss_recur ( double *  p2,
double *  dp2,
double *  p1,
double  x,
int  order 
)

Definition at line 8085 of file ROL_SandiaRulesDef.hpp.

Referenced by hermite_ss_root().

void ROL::SandiaRules::hermite_ss_root ( double *  x,
int  order,
double *  dp2,
double *  p1 
)

Definition at line 8160 of file ROL_SandiaRulesDef.hpp.

References hermite_ss_recur(), r8_abs(), and r8_epsilon().

Referenced by hermite_ss_compute().

int ROL::SandiaRules::i4_choose ( int  n,
int  k 
)

Definition at line 8224 of file ROL_SandiaRulesDef.hpp.

References i4_max(), and i4_min().

int ROL::SandiaRules::i4_log_2 ( int  i)

Definition at line 8299 of file ROL_SandiaRulesDef.hpp.

int ROL::SandiaRules::i4_max ( int  i1,
int  i2 
)
int ROL::SandiaRules::i4_min ( int  i1,
int  i2 
)
int ROL::SandiaRules::i4_power ( int  i,
int  j 
)
void ROL::SandiaRules::i4mat_copy ( int  m,
int  n,
int  a1[],
int  a2[] 
)

Definition at line 8533 of file ROL_SandiaRulesDef.hpp.

int * ROL::SandiaRules::i4mat_copy_new ( int  m,
int  n,
int  a1[] 
)

Definition at line 8580 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::i4mat_transpose_print ( int  m,
int  n,
int  a[],
std::string  title 
)

Definition at line 8630 of file ROL_SandiaRulesDef.hpp.

References i4mat_transpose_print_some().

void ROL::SandiaRules::i4mat_transpose_print_some ( int  m,
int  n,
int  a[],
int  ilo,
int  jlo,
int  ihi,
int  jhi,
std::string  title 
)

Definition at line 8671 of file ROL_SandiaRulesDef.hpp.

References i4_max(), i4_min(), and INCX.

Referenced by i4mat_transpose_print().

void ROL::SandiaRules::i4mat_write ( std::string  output_filename,
int  m,
int  n,
int  table[] 
)

Definition at line 8771 of file ROL_SandiaRulesDef.hpp.

int * ROL::SandiaRules::i4vec_add_new ( int  n,
int  a[],
int  b[] 
)

Definition at line 8837 of file ROL_SandiaRulesDef.hpp.

bool ROL::SandiaRules::i4vec_any_lt ( int  n,
int  a[],
int  b[] 
)
void ROL::SandiaRules::i4vec_copy ( int  n,
int  a1[],
int  a2[] 
)

Definition at line 8938 of file ROL_SandiaRulesDef.hpp.

int * ROL::SandiaRules::i4vec_copy_new ( int  n,
int  a1[] 
)

Definition at line 8981 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::i4vec_min_mv ( int  m,
int  n,
int  u[],
int  v[],
int  w[] 
)

Definition at line 9027 of file ROL_SandiaRulesDef.hpp.

References i4_min().

void ROL::SandiaRules::i4vec_print ( int  n,
int  a[],
std::string  title 
)

Definition at line 9080 of file ROL_SandiaRulesDef.hpp.

int ROL::SandiaRules::i4vec_product ( int  n,
int  a[] 
)

Definition at line 9127 of file ROL_SandiaRulesDef.hpp.

int ROL::SandiaRules::i4vec_sum ( int  n,
int  a[] 
)

Definition at line 9183 of file ROL_SandiaRulesDef.hpp.

Referenced by ROL::Quadrature< Real >::Quadrature().

void ROL::SandiaRules::i4vec_zero ( int  n,
int  a[] 
)

Definition at line 9239 of file ROL_SandiaRulesDef.hpp.

int * ROL::SandiaRules::i4vec_zero_new ( int  n)

Definition at line 9280 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::imtqlx ( int  n,
double  d[],
double  e[],
double  z[] 
)
void ROL::SandiaRules::jacobi_compute ( int  order,
double  alpha,
double  beta,
double  x[],
double  w[] 
)

Definition at line 9519 of file ROL_SandiaRulesDef.hpp.

References imtqlx(), and r8_gamma().

Referenced by jacobi_compute_np(), jacobi_compute_points(), and jacobi_compute_weights().

void ROL::SandiaRules::jacobi_compute_np ( int  order,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 9632 of file ROL_SandiaRulesDef.hpp.

References jacobi_compute().

void ROL::SandiaRules::jacobi_compute_points ( int  order,
double  alpha,
double  beta,
double  x[] 
)
void ROL::SandiaRules::jacobi_compute_points_np ( int  order,
int  np,
double  p[],
double  x[] 
)

Definition at line 9744 of file ROL_SandiaRulesDef.hpp.

References jacobi_compute_points().

void ROL::SandiaRules::jacobi_compute_weights ( int  order,
double  alpha,
double  beta,
double  w[] 
)
void ROL::SandiaRules::jacobi_compute_weights_np ( int  order,
int  np,
double  p[],
double  w[] 
)

Definition at line 9832 of file ROL_SandiaRulesDef.hpp.

References jacobi_compute_weights().

double ROL::SandiaRules::jacobi_integral ( int  expon,
double  alpha,
double  beta 
)

Definition at line 9878 of file ROL_SandiaRulesDef.hpp.

References r8_gamma(), and r8_hyper_2f1().

void ROL::SandiaRules::jacobi_ss_compute ( int  order,
double  alpha,
double  beta,
double  x[],
double  w[] 
)

Definition at line 9958 of file ROL_SandiaRulesDef.hpp.

References jacobi_ss_root(), r8_abs(), and r8_gamma().

void ROL::SandiaRules::jacobi_ss_recur ( double *  p2,
double *  dp2,
double *  p1,
double  x,
int  order,
double  alpha,
double  beta,
double  b[],
double  c[] 
)

Definition at line 10202 of file ROL_SandiaRulesDef.hpp.

Referenced by jacobi_ss_root().

void ROL::SandiaRules::jacobi_ss_root ( double *  x,
int  order,
double  alpha,
double  beta,
double *  dp2,
double *  p1,
double  b[],
double  c[] 
)

Definition at line 10275 of file ROL_SandiaRulesDef.hpp.

References jacobi_ss_recur(), r8_abs(), and r8_epsilon().

Referenced by jacobi_ss_compute().

void ROL::SandiaRules::laguerre_compute ( int  n,
double  x[],
double  w[] 
)
void ROL::SandiaRules::laguerre_compute_np ( int  order,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 10427 of file ROL_SandiaRulesDef.hpp.

References laguerre_compute().

void ROL::SandiaRules::laguerre_compute_points ( int  order,
double  x[] 
)
void ROL::SandiaRules::laguerre_compute_points_np ( int  order,
int  np,
double  p[],
double  x[] 
)

Definition at line 10533 of file ROL_SandiaRulesDef.hpp.

References laguerre_compute_points().

void ROL::SandiaRules::laguerre_compute_weights ( int  order,
double  w[] 
)
void ROL::SandiaRules::laguerre_compute_weights_np ( int  order,
int  np,
double  p[],
double  w[] 
)

Definition at line 10609 of file ROL_SandiaRulesDef.hpp.

References laguerre_compute_weights().

double ROL::SandiaRules::laguerre_integral ( int  expon)

Definition at line 10646 of file ROL_SandiaRulesDef.hpp.

References r8_factorial().

void ROL::SandiaRules::laguerre_lookup ( int  n,
double  x[],
double  w[] 
)
void ROL::SandiaRules::laguerre_lookup_points ( int  n,
double  x[] 
)

Definition at line 10783 of file ROL_SandiaRulesDef.hpp.

Referenced by laguerre_lookup().

void ROL::SandiaRules::laguerre_lookup_weights ( int  n,
double  w[] 
)

Definition at line 11126 of file ROL_SandiaRulesDef.hpp.

Referenced by laguerre_lookup().

void ROL::SandiaRules::laguerre_ss_compute ( int  order,
double  x[],
double  w[] 
)

Definition at line 11469 of file ROL_SandiaRulesDef.hpp.

References laguerre_ss_root().

void ROL::SandiaRules::laguerre_ss_recur ( double *  p2,
double *  dp2,
double *  p1,
double  x,
int  order,
double  b[],
double  c[] 
)

Definition at line 11620 of file ROL_SandiaRulesDef.hpp.

Referenced by laguerre_ss_root().

void ROL::SandiaRules::laguerre_ss_root ( double *  x,
int  order,
double *  dp2,
double *  p1,
double  b[],
double  c[] 
)

Definition at line 11691 of file ROL_SandiaRulesDef.hpp.

References laguerre_ss_recur(), r8_abs(), and r8_epsilon().

Referenced by laguerre_ss_compute().

void ROL::SandiaRules::legendre_compute ( int  n,
double  x[],
double  w[] 
)
void ROL::SandiaRules::legendre_compute_np ( int  order,
int  np,
double  p[],
double  x[],
double  w[] 
)

Definition at line 11843 of file ROL_SandiaRulesDef.hpp.

References legendre_compute().

void ROL::SandiaRules::legendre_compute_points ( int  order,
double  x[] 
)
void ROL::SandiaRules::legendre_compute_points_np ( int  order,
int  np,
double  p[],
double  x[] 
)

Definition at line 11942 of file ROL_SandiaRulesDef.hpp.

References legendre_compute_points().

void ROL::SandiaRules::legendre_compute_weights ( int  order,
double  w[] 
)
void ROL::SandiaRules::legendre_compute_weights_np ( int  order,
int  np,
double  p[],
double  w[] 
)

Definition at line 12018 of file ROL_SandiaRulesDef.hpp.

References legendre_compute_weights().

void ROL::SandiaRules::legendre_dr_compute ( int  order,
double  x[],
double  w[] 
)

Definition at line 12055 of file ROL_SandiaRulesDef.hpp.

double ROL::SandiaRules::legendre_integral ( int  expon)

Definition at line 12228 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::legendre_lookup ( int  n,
double  x[],
double  w[] 
)
void ROL::SandiaRules::legendre_lookup_points ( int  n,
double  x[] 
)

Definition at line 12349 of file ROL_SandiaRulesDef.hpp.

Referenced by legendre_lookup().

void ROL::SandiaRules::legendre_lookup_weights ( int  n,
double  w[] 
)

Definition at line 13082 of file ROL_SandiaRulesDef.hpp.

Referenced by legendre_lookup().

double * ROL::SandiaRules::legendre_zeros ( int  order)

Definition at line 13815 of file ROL_SandiaRulesDef.hpp.

Referenced by r8vec_legendre_new().

void ROL::SandiaRules::level_growth_to_order ( int  dim_num,
int  level[],
int  rule[],
int  growth[],
int  order[] 
)

Definition at line 13967 of file ROL_SandiaRulesDef.hpp.

References i4_max(), and i4_power().

void ROL::SandiaRules::level_to_order_default ( int  dim_num,
int  level[],
int  rule[],
int  order[] 
)

Definition at line 14662 of file ROL_SandiaRulesDef.hpp.

References i4_power().

void ROL::SandiaRules::level_to_order_exponential ( int  dim_num,
int  level[],
int  rule[],
int  order[] 
)

Definition at line 14891 of file ROL_SandiaRulesDef.hpp.

References i4_power().

void ROL::SandiaRules::level_to_order_exponential_slow ( int  dim_num,
int  level[],
int  rule[],
int  order[] 
)

Definition at line 15071 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::level_to_order_linear ( int  dim_num,
int  level[],
int  rule[],
int  order[] 
)

Definition at line 15245 of file ROL_SandiaRulesDef.hpp.

int ROL::SandiaRules::level_to_order_exp_cc ( int  level,
int  growth 
)

Definition at line 15326 of file ROL_SandiaRulesDef.hpp.

References i4_power().

Referenced by ROL::Quadrature< Real >::Quadrature().

int ROL::SandiaRules::level_to_order_exp_f2 ( int  level,
int  growth 
)

Definition at line 15442 of file ROL_SandiaRulesDef.hpp.

References i4_power().

Referenced by ROL::Quadrature< Real >::Quadrature().

int ROL::SandiaRules::level_to_order_exp_gauss ( int  level,
int  growth 
)

Definition at line 15557 of file ROL_SandiaRulesDef.hpp.

References i4_power().

Referenced by ROL::Quadrature< Real >::Quadrature().

int ROL::SandiaRules::level_to_order_exp_gp ( int  level,
int  growth 
)

Definition at line 15671 of file ROL_SandiaRulesDef.hpp.

References i4_power().

Referenced by ROL::Quadrature< Real >::Quadrature().

int ROL::SandiaRules::level_to_order_exp_hgk ( int  level,
int  growth 
)

Definition at line 15813 of file ROL_SandiaRulesDef.hpp.

References i4_max().

Referenced by ROL::Quadrature< Real >::Quadrature().

int ROL::SandiaRules::level_to_order_linear_nn ( int  level,
int  growth 
)

Definition at line 15937 of file ROL_SandiaRulesDef.hpp.

int ROL::SandiaRules::level_to_order_linear_wn ( int  level,
int  growth 
)

Definition at line 16016 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::nc_compute ( int  n,
double  x_min,
double  x_max,
double  x[],
double  w[] 
)
double * ROL::SandiaRules::nc_compute_new ( int  n,
double  x_min,
double  x_max,
double  x[] 
)

Definition at line 16207 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::ncc_compute_points ( int  n,
double  x[] 
)

Definition at line 16317 of file ROL_SandiaRulesDef.hpp.

Referenced by ROL::SandiaRules2::ncc_points().

void ROL::SandiaRules::ncc_compute_weights ( int  n,
double  w[] 
)

Definition at line 16365 of file ROL_SandiaRulesDef.hpp.

References nc_compute().

Referenced by ROL::SandiaRules2::ncc_weights().

void ROL::SandiaRules::nco_compute_points ( int  n,
double  x[] 
)

Definition at line 16419 of file ROL_SandiaRulesDef.hpp.

Referenced by nco_compute_weights(), and ROL::SandiaRules2::nco_points().

void ROL::SandiaRules::nco_compute_weights ( int  n,
double  w[] 
)

Definition at line 16461 of file ROL_SandiaRulesDef.hpp.

References nc_compute(), and nco_compute_points().

Referenced by ROL::SandiaRules2::nco_weights().

void ROL::SandiaRules::ncoh_compute_points ( int  n,
double  x[] 
)

Definition at line 16505 of file ROL_SandiaRulesDef.hpp.

Referenced by ncoh_compute_weights().

void ROL::SandiaRules::ncoh_compute_weights ( int  n,
double  w[] 
)

Definition at line 16552 of file ROL_SandiaRulesDef.hpp.

References nc_compute(), and ncoh_compute_points().

void ROL::SandiaRules::patterson_lookup ( int  n,
double  x[],
double  w[] 
)
void ROL::SandiaRules::patterson_lookup_points ( int  n,
double  x[] 
)
void ROL::SandiaRules::patterson_lookup_points_np ( int  n,
int  np,
double  p[],
double  x[] 
)

Definition at line 17803 of file ROL_SandiaRulesDef.hpp.

References patterson_lookup_points().

void ROL::SandiaRules::patterson_lookup_weights ( int  n,
double  w[] 
)
void ROL::SandiaRules::patterson_lookup_weights_np ( int  n,
int  np,
double  p[],
double  w[] 
)

Definition at line 19008 of file ROL_SandiaRulesDef.hpp.

References patterson_lookup_weights().

int ROL::SandiaRules::point_radial_tol_unique_count ( int  m,
int  n,
double  a[],
double  tol,
int *  seed 
)
void ROL::SandiaRules::point_radial_tol_unique_count_inc1 ( int  m,
int  n1,
double  a1[],
double  tol,
int *  seed,
double  z[],
double  r1[],
int  indx1[],
bool  unique1[],
int *  unique_num1 
)
void ROL::SandiaRules::point_radial_tol_unique_count_inc2 ( int  m,
int  n1,
double  a1[],
int  n2,
double  a2[],
double  tol,
double  z[],
double  r1[],
int  indx1[],
bool  unique1[],
int *  unique_num2 
)
int ROL::SandiaRules::point_radial_tol_unique_index ( int  m,
int  n,
double  a[],
double  tol,
int *  seed,
int  undx[],
int  xdnu[] 
)
void ROL::SandiaRules::point_radial_tol_unique_index_inc1 ( int  m,
int  n1,
double  a1[],
double  tol,
int *  seed,
double  z[],
double  r1[],
int  indx1[],
bool  unique1[],
int *  unique_num1,
int  undx1[],
int  xdnu1[] 
)
void ROL::SandiaRules::point_radial_tol_unique_index_inc2 ( int  m,
int  n1,
double  a1[],
int  n2,
double  a2[],
double  tol,
double  z[],
double  r1[],
int  indx1[],
bool  unique1[],
int  unique_num1,
int  undx1[],
int  xdnu1[],
double  r2[],
int  indx2[],
bool  unique2[],
int *  unique_num2,
int  undx2[],
int  xdnu2[] 
)
void ROL::SandiaRules::point_radial_tol_unique_index_inc3 ( int  m,
int  n1,
double  a1[],
double  r1[],
int  indx1[],
bool  unique1[],
int  unique_num1,
int  undx1[],
int  xdnu1[],
int  n2,
double  a2[],
double  r2[],
int  indx2[],
bool  unique2[],
int  unique_num2,
int  undx2[],
int  xdnu2[],
int *  n3,
double  a3[],
double  r3[],
int  indx3[],
bool  unique3[],
int *  unique_num3,
int  undx3[],
int  xdnu3[] 
)

Definition at line 20138 of file ROL_SandiaRulesDef.hpp.

References r8_huge().

void ROL::SandiaRules::point_unique_index ( int  m,
int  n,
double  a[],
int  unique_num,
int  undx[],
int  xdnu[] 
)

Definition at line 20354 of file ROL_SandiaRulesDef.hpp.

References r8_abs(), r8_max(), and r8col_sort_heap_index_a().

void ROL::SandiaRules::product_mixed_weight ( int  dim_num,
int  order_1d[],
int  order_nd,
int  rule[],
double  alpha[],
double  beta[],
double  weight_nd[] 
)
double ROL::SandiaRules::r8_abs ( double  x)
double ROL::SandiaRules::r8_ceiling ( double  x)

Definition at line 20699 of file ROL_SandiaRulesDef.hpp.

double ROL::SandiaRules::r8_choose ( int  n,
int  k 
)

Definition at line 20756 of file ROL_SandiaRulesDef.hpp.

References i4_max(), and i4_min().

double ROL::SandiaRules::r8_epsilon ( )
double ROL::SandiaRules::r8_factorial ( int  n)

Definition at line 20878 of file ROL_SandiaRulesDef.hpp.

Referenced by laguerre_integral().

double ROL::SandiaRules::r8_factorial2 ( int  n)

Definition at line 20924 of file ROL_SandiaRulesDef.hpp.

Referenced by hermite_integral().

double ROL::SandiaRules::r8_floor ( double  x)

Definition at line 20995 of file ROL_SandiaRulesDef.hpp.

double ROL::SandiaRules::r8_gamma ( double  x)
double ROL::SandiaRules::r8_huge ( )
double ROL::SandiaRules::r8_hyper_2f1 ( double  a,
double  b,
double  c,
double  x 
)

Definition at line 21341 of file ROL_SandiaRulesDef.hpp.

References r8_abs(), r8_gamma(), and r8_psi().

Referenced by gegenbauer_integral(), and jacobi_integral().

double ROL::SandiaRules::r8_max ( double  x,
double  y 
)
double ROL::SandiaRules::r8_min ( double  x,
double  y 
)

Definition at line 21837 of file ROL_SandiaRulesDef.hpp.

double ROL::SandiaRules::r8_mop ( int  i)

Definition at line 21878 of file ROL_SandiaRulesDef.hpp.

double ROL::SandiaRules::r8_psi ( double  xx)

Definition at line 21924 of file ROL_SandiaRulesDef.hpp.

References r8_abs().

Referenced by r8_hyper_2f1().

double ROL::SandiaRules::r8_sign ( double  x)

Definition at line 22165 of file ROL_SandiaRulesDef.hpp.

Referenced by imtqlx().

int ROL::SandiaRules::r8col_compare ( int  m,
int  n,
double  a[],
int  i,
int  j 
)

Definition at line 22206 of file ROL_SandiaRulesDef.hpp.

Referenced by r8col_sort_heap_a().

void ROL::SandiaRules::r8col_sort_heap_a ( int  m,
int  n,
double  a[] 
)

Definition at line 22312 of file ROL_SandiaRulesDef.hpp.

References r8col_compare(), r8col_swap(), and sort_heap_external().

int * ROL::SandiaRules::r8col_sort_heap_index_a ( int  m,
int  n,
double  a[] 
)
int ROL::SandiaRules::r8col_sorted_unique_count ( int  m,
int  n,
double  a[],
double  tol 
)

Definition at line 22555 of file ROL_SandiaRulesDef.hpp.

References r8_abs(), and r8_max().

void ROL::SandiaRules::r8col_swap ( int  m,
int  n,
double  a[],
int  j1,
int  j2 
)

Definition at line 22640 of file ROL_SandiaRulesDef.hpp.

Referenced by r8col_sort_heap_a().

void ROL::SandiaRules::r8col_tol_undex ( int  x_dim,
int  x_num,
double  x_val[],
int  x_unique_num,
double  tol,
int  undx[],
int  xdnu[] 
)

Definition at line 22723 of file ROL_SandiaRulesDef.hpp.

References r8_abs(), r8_max(), and r8col_sort_heap_index_a().

int ROL::SandiaRules::r8col_tol_unique_count ( int  m,
int  n,
double  a[],
double  tol 
)

Definition at line 22886 of file ROL_SandiaRulesDef.hpp.

References r8_abs(), r8_max(), and r8col_sort_heap_index_a().

void ROL::SandiaRules::r8col_undex ( int  x_dim,
int  x_num,
double  x_val[],
int  x_unique_num,
double  tol,
int  undx[],
int  xdnu[] 
)

Definition at line 23000 of file ROL_SandiaRulesDef.hpp.

References r8_abs(), r8_max(), and r8col_sort_heap_index_a().

void ROL::SandiaRules::r8col_unique_index ( int  m,
int  n,
double  a[],
double  tol,
int  unique_index[] 
)

Definition at line 23144 of file ROL_SandiaRulesDef.hpp.

References r8_abs(), and r8_max().

void ROL::SandiaRules::r8mat_transpose_print ( int  m,
int  n,
double  a[],
std::string  title 
)

Definition at line 23228 of file ROL_SandiaRulesDef.hpp.

References r8mat_transpose_print_some().

void ROL::SandiaRules::r8mat_transpose_print_some ( int  m,
int  n,
double  a[],
int  ilo,
int  jlo,
int  ihi,
int  jhi,
std::string  title 
)

Definition at line 23268 of file ROL_SandiaRulesDef.hpp.

References i4_max(), i4_min(), and INCX.

Referenced by r8mat_transpose_print().

void ROL::SandiaRules::r8mat_write ( std::string  output_filename,
int  m,
int  n,
double  table[] 
)

Definition at line 23359 of file ROL_SandiaRulesDef.hpp.

double ROL::SandiaRules::r8poly_ant_val ( int  n,
double  poly_cof[],
double  xval 
)

Definition at line 23425 of file ROL_SandiaRulesDef.hpp.

Referenced by hermite_interpolant_rule().

double * ROL::SandiaRules::r8vec_chebyshev_new ( int  n,
double  a_first,
double  a_last 
)

Definition at line 23477 of file ROL_SandiaRulesDef.hpp.

int ROL::SandiaRules::r8vec_compare ( int  n,
double  a[],
double  b[] 
)

Definition at line 23547 of file ROL_SandiaRulesDef.hpp.

Referenced by r8col_sort_heap_index_a().

void ROL::SandiaRules::r8vec_copy ( int  n,
double  a1[],
double  a2[] 
)

Definition at line 23618 of file ROL_SandiaRulesDef.hpp.

Referenced by patterson_lookup_points(), and patterson_lookup_weights().

double * ROL::SandiaRules::r8vec_copy_new ( int  n,
double  a1[] 
)

Definition at line 23657 of file ROL_SandiaRulesDef.hpp.

double ROL::SandiaRules::r8vec_diff_norm_li ( int  n,
double  a[],
double  b[] 
)

Definition at line 23703 of file ROL_SandiaRulesDef.hpp.

References r8_abs(), and r8_max().

void ROL::SandiaRules::r8vec_direct_product2 ( int  factor_index,
int  factor_order,
double  factor_value[],
int  factor_num,
int  point_num,
double  w[] 
)

Definition at line 23753 of file ROL_SandiaRulesDef.hpp.

Referenced by product_mixed_weight().

double ROL::SandiaRules::r8vec_dot_product ( int  n,
double  a1[],
double  a2[] 
)

Definition at line 23919 of file ROL_SandiaRulesDef.hpp.

double ROL::SandiaRules::r8vec_i4vec_dot_product ( int  n,
double  r8vec[],
int  i4vec[] 
)

Definition at line 23964 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::r8vec_index_sorted_range ( int  n,
double  r[],
int  indx[],
double  r_lo,
double  r_hi,
int *  i_lo,
int *  i_hi 
)
void ROL::SandiaRules::r8vec_indexed_heap_d ( int  n,
double  a[],
int  indx[] 
)

Definition at line 24191 of file ROL_SandiaRulesDef.hpp.

Referenced by r8vec_indexed_heap_d_extract().

int ROL::SandiaRules::r8vec_indexed_heap_d_extract ( int *  n,
double  a[],
int  indx[] 
)

Definition at line 24310 of file ROL_SandiaRulesDef.hpp.

References r8vec_indexed_heap_d().

void ROL::SandiaRules::r8vec_indexed_heap_d_insert ( int *  n,
double  a[],
int  indx[],
int  indx_insert 
)

Definition at line 24400 of file ROL_SandiaRulesDef.hpp.

int ROL::SandiaRules::r8vec_indexed_heap_d_max ( int  n,
double  a[],
int  indx[] 
)

Definition at line 24479 of file ROL_SandiaRulesDef.hpp.

double * ROL::SandiaRules::r8vec_legendre_new ( int  n,
double  a_first,
double  a_last 
)

Definition at line 24536 of file ROL_SandiaRulesDef.hpp.

References legendre_zeros().

double * ROL::SandiaRules::r8vec_linspace_new ( int  n,
double  a_first,
double  a_last 
)

Definition at line 24584 of file ROL_SandiaRulesDef.hpp.

Referenced by hce_compute().

double ROL::SandiaRules::r8vec_min ( int  n,
double  r8vec[] 
)

Definition at line 24639 of file ROL_SandiaRulesDef.hpp.

double ROL::SandiaRules::r8vec_min_pos ( int  n,
double  a[] 
)

Definition at line 24688 of file ROL_SandiaRulesDef.hpp.

References r8_huge().

void ROL::SandiaRules::r8vec_print ( int  n,
double  a[],
std::string  title 
)

Definition at line 24742 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::r8vec_scale ( double  s,
int  n,
double  a[] 
)

Definition at line 24790 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::r8vec_sort_heap_index_a ( int  n,
double  a[],
int  indx[] 
)
int * ROL::SandiaRules::r8vec_sort_heap_index_a_new ( int  n,
double  a[] 
)
void ROL::SandiaRules::r8vec_stutter ( int  n,
double  a[],
int  m,
double  am[] 
)

Definition at line 25097 of file ROL_SandiaRulesDef.hpp.

Referenced by hcc_compute(), hcc_compute_points(), and hce_compute().

double ROL::SandiaRules::r8vec_sum ( int  n,
double  a[] 
)
void ROL::SandiaRules::r8vec_uniform_01 ( int  n,
int *  seed,
double  r[] 
)

Definition at line 25198 of file ROL_SandiaRulesDef.hpp.

double * ROL::SandiaRules::r8vec_uniform_01_new ( int  n,
int *  seed 
)
void ROL::SandiaRules::r8vec_zero ( int  n,
double  a[] 
)

Definition at line 25397 of file ROL_SandiaRulesDef.hpp.

void ROL::SandiaRules::sort_heap_external ( int  n,
int *  indx,
int *  i,
int *  j,
int  isgn 
)

Definition at line 25438 of file ROL_SandiaRulesDef.hpp.

Referenced by r8col_sort_heap_a().

void ROL::SandiaRules::timestamp ( )

Definition at line 25629 of file ROL_SandiaRulesDef.hpp.

References TIME_SIZE.

void ROL::SandiaRules::vec_colex_next3 ( int  dim_num,
int  base[],
int  a[],
bool *  more 
)

Definition at line 25679 of file ROL_SandiaRulesDef.hpp.


The documentation for this class was generated from the following files: