The primary namespace for DAKOTA. More...
Classes | |
class | AnalysisCode |
Base class providing common functionality for derived classes (SysCallAnalysisCode and ForkAnalysisCode) which spawn separate processes for managing simulations. More... | |
class | ApplicationInterface |
Derived class within the interface class hierarchy for supporting interfaces to simulation codes. More... | |
class | ApproximationInterface |
Derived class within the interface class hierarchy for supporting approximations to simulation-based results. More... | |
class | APPSEvalMgr |
Evaluation manager class for APPSPACK. More... | |
class | APPSOptimizer |
Wrapper class for APPSPACK. More... | |
class | COLINApplication |
class | COLINOptimizer |
Wrapper class for optimizers defined using COLIN. More... | |
class | CollaborativeHybridStrategy |
Strategy for hybrid minimization using multiple collaborating optimization and nonlinear least squares methods. More... | |
class | GetLongOpt |
GetLongOpt is a general command line utility from S. Manoharan (Advanced Computer Research Institute, Lyon, France). More... | |
class | CommandLineHandler |
Utility class for managing command line inputs to DAKOTA. More... | |
class | CommandShell |
Utility class which defines convenience operators for spawning processes with system calls. More... | |
class | ConcurrentStrategy |
Strategy for multi-start iteration or pareto set optimization. More... | |
class | CONMINOptimizer |
Wrapper class for the CONMIN optimization library. More... | |
class | ActiveSet |
Container class for active set tracking information. Contains the active set request vector and the derivative variables vector. More... | |
class | Analyzer |
Base class for NonD, DACE, and ParamStudy branches of the iterator hierarchy. More... | |
class | Approximation |
Base class for the approximation class hierarchy. More... | |
class | BiStream |
The binary input stream class. Overloads the >> operator for all data types. More... | |
class | BoStream |
The binary output stream class. Overloads the << operator for all data types. More... | |
class | Constraints |
Base class for the variable constraints class hierarchy. More... | |
class | Graphics |
The Graphics class provides a single interface to 2D (motif) and 3D (PLPLOT) graphics as well as tabular cataloguing of data for post-processing with Matlab, Tecplot, etc. More... | |
class | Interface |
Base class for the interface class hierarchy. More... | |
class | Iterator |
Base class for the iterator class hierarchy. More... | |
class | LeastSq |
Base class for the nonlinear least squares branch of the iterator hierarchy. More... | |
class | Minimizer |
Base class for the optimizer and least squares branches of the iterator hierarchy. More... | |
class | Model |
Base class for the model class hierarchy. More... | |
class | NonD |
Base class for all nondetermistic iterators (the DAKOTA/UQ branch). More... | |
class | Optimizer |
Base class for the optimizer branch of the iterator hierarchy. More... | |
class | PStudyDACE |
Base class for managing common aspects of parameter studies and design of experiments methods. More... | |
class | ResponseRep |
Container class for response functions and their derivatives. ResponseRep provides the body class. More... | |
class | Response |
Container class for response functions and their derivatives. Response provides the handle class. More... | |
class | Strategy |
Base class for the strategy class hierarchy. More... | |
class | String |
Dakota::String class, used as main string class for Dakota. More... | |
class | Variables |
Base class for the variables class hierarchy. More... | |
class | Verification |
Base class for managing common aspects of verification studies. More... | |
class | DataFitSurrModel |
Derived model class within the surrogate model branch for managing data fit surrogates (global and local) More... | |
class | DataInterface |
Handle class for interface specification data. More... | |
class | DataMethodRep |
Body class for method specification data. More... | |
class | DataMethod |
Handle class for method specification data. More... | |
class | DataModelRep |
Body class for model specification data. More... | |
class | DataModel |
Handle class for model specification data. More... | |
class | DataResponsesRep |
Body class for responses specification data. More... | |
class | DataResponses |
Handle class for responses specification data. More... | |
class | DataStrategyRep |
Body class for strategy specification data. More... | |
class | DataStrategy |
Handle class for strategy specification data. More... | |
class | DataVariablesRep |
Body class for variables specification data. More... | |
class | DataVariables |
Handle class for variables specification data. More... | |
class | DDACEDesignCompExp |
Wrapper class for the DDACE design of experiments library. More... | |
class | DirectApplicInterface |
Derived application interface class which spawns simulation codes and testers using direct procedure calls. More... | |
class | DOTOptimizer |
Wrapper class for the DOT optimization library. More... | |
class | EffGlobalMinimizer |
Implementation of Efficient Global Optimization/Least Squares algorithms. More... | |
class | EmbeddedHybridStrategy |
Strategy for closely-coupled hybrid minimization, typically involving the embedding of local search methods within global search methods. More... | |
class | ForkAnalysisCode |
Derived class in the AnalysisCode class hierarchy which spawns simulations using forks. More... | |
class | ForkApplicInterface |
Derived application interface class which spawns simulation codes using forks. More... | |
class | FSUDesignCompExp |
Wrapper class for the FSUDace QMC/CVT library. More... | |
class | GaussProcApproximation |
Derived approximation class for Gaussian Process implementation. More... | |
struct | BaseConstructor |
Dummy struct for overloading letter-envelope constructors. More... | |
struct | NoDBBaseConstructor |
Dummy struct for overloading constructors used in on-the-fly instantiations. More... | |
struct | RecastBaseConstructor |
Dummy struct for overloading constructors used in on-the-fly Model instantiations. More... | |
class | GridApplicInterface |
Derived application interface class which spawns simulation codes using grid services such as Condor or Globus. More... | |
class | HierarchSurrModel |
Derived model class within the surrogate model branch for managing hierarchical surrogates (models of varying fidelity). More... | |
class | HybridStrategy |
Base class for hybrid minimization strategies. More... | |
class | JEGAOptimizer |
A version of Dakota::Optimizer for instantiation of John Eddy's Genetic Algorithms (JEGA). More... | |
class | MergedConstraints |
Derived class within the Constraints hierarchy which employs the merged data view. More... | |
class | MergedVariables |
Derived class within the Variables hierarchy which employs the merged data view. More... | |
class | MixedConstraints |
Derived class within the Constraints hierarchy which employs the default data view (no variable or domain type array merging). More... | |
class | MixedVariables |
Derived class within the Variables hierarchy which employs the default data view (no variable or domain type array merging). More... | |
class | MPIPackBuffer |
Class for packing MPI message buffers. More... | |
class | MPIUnpackBuffer |
Class for unpacking MPI message buffers. More... | |
class | NCSUOptimizer |
Wrapper class for the NCSU DIRECT optimization library. More... | |
class | NestedModel |
Derived model class which performs a complete sub-iterator execution within every evaluation of the model. More... | |
class | NIDRProblemDescDB |
The derived input file database utilizing the new IDR parser. More... | |
struct | NL2Res |
Auxiliary information passed to calcr and calcj via ur. More... | |
class | NL2SOLLeastSq |
Wrapper class for the NL2SOL nonlinear least squares library. More... | |
class | NLPQLPOptimizer |
Wrapper class for the NLPQLP optimization library, Version 2.0. More... | |
class | NLSSOLLeastSq |
Wrapper class for the NLSSOL nonlinear least squares library. More... | |
class | NonDAdaptImpSampling |
Class for the Adaptive Importance Sampling methods within DAKOTA. More... | |
class | NonDBayesCalibration |
Base class for Bayesian inference: generates posterior distribution on model parameters given experimental data. More... | |
class | NonDCalibration |
class | NonDCubature |
Derived nondeterministic class that generates N-dimensional numerical cubature points for evaluation of expectation integrals. More... | |
class | NonDExpansion |
Base class for polynomial chaos expansions (PCE) and stochastic collocation (SC) More... | |
class | NonDGlobalEvidence |
Class for the Dempster-Shafer Evidence Theory methods within DAKOTA/UQ. More... | |
class | NonDGlobalInterval |
Class for using global nongradient-based optimization approaches to calculate interval bounds for epistemic uncertainty quantification. More... | |
class | NonDGlobalReliability |
Class for global reliability methods within DAKOTA/UQ. More... | |
class | NonDGlobalSingleInterval |
Class for using global nongradient-based optimization approaches to calculate interval bounds for epistemic uncertainty quantification. More... | |
class | NonDGPMSABayesCalibration |
Generates posterior distribution on model parameters given experiment data. More... | |
class | NonDIncremLHSSampling |
Performs icremental LHS sampling for uncertainty quantification. More... | |
class | NonDIntegration |
Derived nondeterministic class that generates N-dimensional numerical integration points for evaluation of expectation integrals. More... | |
class | NonDInterval |
Base class for interval-based methods within DAKOTA/UQ. More... | |
class | NonDLHSEvidence |
Class for the Dempster-Shafer Evidence Theory methods within DAKOTA/UQ. More... | |
class | NonDLHSInterval |
Class for the LHS-based interval methods within DAKOTA/UQ. More... | |
class | NonDLHSSampling |
Performs LHS and Monte Carlo sampling for uncertainty quantification. More... | |
class | NonDLHSSingleInterval |
Class for pure interval propagation using LHS. More... | |
class | NonDLocalEvidence |
Class for the Dempster-Shafer Evidence Theory methods within DAKOTA/UQ. More... | |
class | NonDLocalInterval |
Class for using local gradient-based optimization approaches to calculate interval bounds for epistemic uncertainty quantification. More... | |
class | NonDLocalReliability |
Class for the reliability methods within DAKOTA/UQ. More... | |
class | NonDLocalSingleInterval |
Class for using local gradient-based optimization approaches to calculate interval bounds for epistemic uncertainty quantification. More... | |
class | NonDPolynomialChaos |
Nonintrusive polynomial chaos expansion approaches to uncertainty quantification. More... | |
class | NonDQuadrature |
Derived nondeterministic class that generates N-dimensional numerical quadrature points for evaluation of expectation integrals over uncorrelated standard normals/uniforms/exponentials/betas/gammas. More... | |
class | NonDQUESOBayesCalibration |
Bayesian inference using the QUESO library from UT Austin. More... | |
class | NonDReliability |
Base class for the reliability methods within DAKOTA/UQ. More... | |
class | NonDSampling |
Base class for common code between NonDLHSSampling, NonDIncremLHSSampling, and NonDAdaptImpSampling. More... | |
class | NonDSparseGrid |
Derived nondeterministic class that generates N-dimensional Smolyak sparse grids for numerical evaluation of expectation integrals over independent standard random variables. More... | |
class | NonDStochCollocation |
Nonintrusive stochastic collocation approaches to uncertainty quantification. More... | |
class | NPSOLOptimizer |
Wrapper class for the NPSOL optimization library. More... | |
class | ParallelLevel |
Container class for the data associated with a single level of communicator partitioning. More... | |
class | ParallelConfiguration |
Container class for a set of ParallelLevel list iterators that collectively identify a particular multilevel parallel configuration. More... | |
class | ParallelLibrary |
Class for partitioning multiple levels of parallelism and managing message passing within these levels. More... | |
class | ParamResponsePair |
Container class for a variables object, a response object, and an evaluation id. More... | |
class | ParamStudy |
Class for vector, list, centered, and multidimensional parameter studies. More... | |
class | PecosApproximation |
Derived approximation class for global basis polynomials. More... | |
class | ProblemDescDB |
The database containing information parsed from the DAKOTA input file. More... | |
struct | partial_prp_hash |
wrapper to delegate to the ParamResponsePair hash_value function More... | |
struct | partial_prp_equality |
predicate for comparing ONLY the idInterface and Vars attributes of PRPair More... | |
class | PSUADEDesignCompExp |
Wrapper class for the PSUADE library. More... | |
class | RecastModel |
Derived model class which provides a thin wrapper around a sub-model in order to recast the form of its inputs and/or outputs. More... | |
class | RichExtrapVerification |
Class for Richardson extrapolation for code and solution verification. More... | |
class | SensAnalysisGlobal |
Class for a utility class containing correlation calculations and variance-based decomposition. More... | |
class | SequentialHybridStrategy |
Strategy for sequential hybrid minimization using multiple optimization and nonlinear least squares methods on multiple models of varying fidelity. More... | |
class | SharedVariablesDataRep |
The representation of a SharedVariablesData instance. This representation, or body, may be shared by multiple SharedVariablesData handle instances. More... | |
class | SharedVariablesData |
Container class encapsulating variables data that can be shared among a set of Variables instances. More... | |
class | SingleMethodStrategy |
Simple fall-through strategy for running a single iterator on a single model. More... | |
class | SingleModel |
Derived model class which utilizes a single interface to map variables into responses. More... | |
class | SNLLBase |
Base class for OPT++ optimization and least squares methods. More... | |
class | SNLLLeastSq |
Wrapper class for the OPT++ optimization library. More... | |
class | SNLLOptimizer |
Wrapper class for the OPT++ optimization library. More... | |
class | SOLBase |
Base class for Stanford SOL software. More... | |
class | SurfpackApproximation |
Derived approximation class for Surfpack approximation classes. Interface between Surfpack and Dakota. More... | |
class | SurrBasedGlobalMinimizer |
The global surrogate-based minimizer which sequentially minimizes and updates a global surrogate model without trust region controls. More... | |
class | SurrBasedLocalMinimizer |
Class for provably-convergent local surrogate-based optimization and nonlinear least squares. More... | |
class | SurrBasedMinimizer |
Base class for local/global surrogate-based optimization/least squares. More... | |
class | SurrogateModel |
Base class for surrogate models (DataFitSurrModel and HierarchSurrModel). More... | |
class | SysCallAnalysisCode |
Derived class in the AnalysisCode class hierarchy which spawns simulations using system calls. More... | |
class | SysCallApplicInterface |
Derived application interface class which spawns simulation codes using system calls. More... | |
class | TANA3Approximation |
Derived approximation class for TANA-3 two-point exponential approximation (a multipoint approximation). More... | |
class | TaylorApproximation |
Derived approximation class for first- or second-order Taylor series (a local approximation). More... | |
class | TrackerHTTP |
TrackerHTTP: a usage tracking module that uses HTTP/HTTPS via the curl library. More... | |
Typedefs | |
typedef void(* | p_vf )(void) |
typedef struct Dakota::Libentry | Libentry |
typedef struct Dakota::SharedLib | SharedLib |
typedef double | Real |
typedef Teuchos::SerialDenseVector < int, Real > | RealVector |
typedef Teuchos::SerialDenseVector < int, int > | IntVector |
typedef Teuchos::SerialDenseMatrix < int, Real > | RealMatrix |
typedef Teuchos::SerialSymDenseMatrix < int, Real > | RealSymMatrix |
typedef std::deque< bool > | BoolDeque |
typedef std::vector< BoolDeque > | BoolDequeArray |
typedef std::vector< Real > | RealArray |
typedef std::vector< RealArray > | Real2DArray |
typedef std::vector< int > | IntArray |
typedef std::vector< IntArray > | Int2DArray |
typedef std::vector< short > | ShortArray |
typedef std::vector< unsigned short > | UShortArray |
typedef std::vector< UShortArray > | UShort2DArray |
typedef std::vector < UShort2DArray > | UShort3DArray |
typedef std::vector< size_t > | SizetArray |
typedef std::vector< SizetArray > | Sizet2DArray |
typedef std::vector< String > | StringArray |
typedef std::vector< StringArray > | String2DArray |
typedef boost::multi_array_types::index_range | idx_range |
typedef boost::multi_array < String, 1 > | StringMultiArray |
typedef StringMultiArray::array_view < 1 >::type | StringMultiArrayView |
typedef StringMultiArray::const_array_view < 1 >::type | StringMultiArrayConstView |
typedef boost::multi_array < unsigned short, 1 > | UShortMultiArray |
typedef UShortMultiArray::array_view < 1 >::type | UShortMultiArrayView |
typedef UShortMultiArray::const_array_view < 1 >::type | UShortMultiArrayConstView |
typedef boost::multi_array < size_t, 1 > | SizetMultiArray |
typedef SizetMultiArray::array_view < 1 >::type | SizetMultiArrayView |
typedef SizetMultiArray::const_array_view < 1 >::type | SizetMultiArrayConstView |
typedef std::vector< RealVector > | RealVectorArray |
typedef std::vector < RealVectorArray > | RealVector2DArray |
typedef std::vector< RealMatrix > | RealMatrixArray |
typedef std::vector < RealSymMatrix > | RealSymMatrixArray |
typedef std::vector< IntVector > | IntVectorArray |
typedef std::vector< Variables > | VariablesArray |
typedef std::vector< Response > | ResponseArray |
typedef std::vector < ParamResponsePair > | PRPArray |
typedef std::vector< PRPArray > | PRP2DArray |
typedef std::vector < Pecos::SurrogateDataPoint > | SDPArray |
typedef std::vector< SDPArray > | SDP2DArray |
typedef std::vector< Model > | ModelArray |
typedef std::vector< Iterator > | IteratorArray |
typedef std::list< bool > | BoolList |
typedef std::list< int > | IntList |
typedef std::list< size_t > | SizetList |
typedef std::list< Real > | RealList |
typedef std::list< String > | StringList |
typedef std::list < Pecos::SurrogateDataPoint > | SDPList |
typedef std::list< Variables > | VariablesList |
typedef std::list< Interface > | InterfaceList |
typedef std::list< Response > | ResponseList |
typedef std::list< Model > | ModelList |
typedef std::list< Iterator > | IteratorList |
typedef std::pair< int, String > | IntStringPair |
typedef std::pair< Real, Real > | RealRealPair |
typedef std::set< Real > | RealSet |
typedef std::set< int > | IntSet |
typedef std::vector< RealSet > | RealSetArray |
typedef std::vector< IntSet > | IntSetArray |
typedef std::map< int, int > | IntIntMap |
typedef std::map< int, short > | IntShortMap |
typedef std::map< int, RealVector > | IntRealVectorMap |
typedef std::map< int, ActiveSet > | IntActiveSetMap |
typedef std::map< int, Variables > | IntVariablesMap |
typedef std::map< int, Response > | IntResponseMap |
typedef std::map< IntArray, size_t > | IntArraySizetMap |
typedef std::multimap < RealRealPair, ParamResponsePair > | RealPairPRPMultiMap |
typedef IntList::iterator | ILIter |
typedef IntList::const_iterator | ILCIter |
typedef SizetList::iterator | StLIter |
typedef SizetList::const_iterator | StLCIter |
typedef RealList::iterator | RLIter |
typedef RealList::const_iterator | RLCIter |
typedef StringList::iterator | StringLIter |
typedef StringList::const_iterator | StringLCIter |
typedef SDPList::iterator | SDPLIter |
typedef SDPList::const_iterator | SDPLCIter |
typedef SDPList::difference_type | SDPLDiffT |
typedef SDPArray::iterator | SDPAIter |
typedef SDP2DArray::iterator | SDP2AIter |
typedef VariablesList::iterator | VarsLIter |
typedef InterfaceList::iterator | InterfLIter |
typedef ResponseList::iterator | RespLIter |
typedef ModelList::iterator | ModelLIter |
typedef IteratorList::iterator | IterLIter |
typedef std::list < ParallelLevel >::iterator | ParLevLIter |
typedef std::list < ParallelConfiguration > ::iterator | ParConfigLIter |
typedef IntSet::iterator | ISIter |
typedef IntSet::const_iterator | ISCIter |
typedef IntIntMap::iterator | IntIntMIter |
typedef IntIntMap::const_iterator | IntIntMCIter |
typedef IntShortMap::iterator | IntShMIter |
typedef IntRealVectorMap::iterator | IntRDVMIter |
typedef IntRealVectorMap::const_iterator | IntRDVMCIter |
typedef IntActiveSetMap::iterator | IntASMIter |
typedef IntVariablesMap::iterator | IntVarsMIter |
typedef IntVariablesMap::const_iterator | IntVarsMCIter |
typedef IntResponseMap::iterator | IntRespMIter |
typedef IntResponseMap::const_iterator | IntRespMCIter |
typedef void(* | dl_find_optimum_t )(void *, Optimizer1 *, char *) |
typedef void(* | dl_destructor_t )(void **) |
typedef struct Dakota::Filesys_buf | Filesys_buf |
typedef int(* | ftw_fn )(const char *file, const struct stat *, int ftype, int depth, void *v) |
typedef struct dirent | dirent |
typedef struct Dakota::Cbuf | Cbuf |
typedef struct Dakota::Buf | Buf |
typedef struct Dakota::Finfo | Finfo |
typedef Teuchos::SerialDenseSolver < int, Real > | RealSolver |
typedef Teuchos::SerialSpdDenseSolver < int, Real > | RealSpdSolver |
typedef int(* | start_grid_computing_t )(char *analysis_driver_script, char *params_file, char *results_file) |
definition of start grid computing type (function pointer) | |
typedef int(* | perform_analysis_t )(char *iteration_num) |
definition of perform analysis type (function pointer) | |
typedef int *(* | get_jobs_completed_t )() |
definition of get completed jobs type (function pointer) | |
typedef int(* | stop_grid_computing_t )() |
definition of stop grid computing type (function pointer) | |
typedef unsigned char | u_char |
typedef unsigned short | u_short |
typedef unsigned int | u_int |
typedef unsigned long | u_long |
typedef long long | long_long |
typedef unsigned long | UL |
typedef void(* | Calcrj )(int *n, int *p, Real *x, int *nf, Real *r, int *ui, void *ur, Vf vf) |
typedef void(* | Vf )() |
typedef bmi::multi_index_container < Dakota::ParamResponsePair, bmi::indexed_by < bmi::ordered_unique < bmi::tag< ordered > , bmi::const_mem_fun < Dakota::ParamResponsePair, const IntStringPair &,&Dakota::ParamResponsePair::eval_interface_ids > >, bmi::hashed_non_unique < bmi::tag< hashed > , bmi::identity < Dakota::ParamResponsePair > , partial_prp_hash, partial_prp_equality > > > | PRPMultiIndexCache |
Boost Multi-Index Container for caching ParamResponsePairs. | |
typedef PRPMultiIndexCache | PRPCache |
typedef PRPCache::index_iterator < ordered >::type | PRPCacheOIter |
typedef PRPCache::index_const_iterator < ordered >::type | PRPCacheOCIter |
typedef PRPCache::index_iterator < hashed >::type | PRPCacheHIter |
typedef PRPCache::index_const_iterator < hashed >::type | PRPCacheHCIter |
typedef PRPCacheOIter | PRPCacheIter |
typedef PRPCacheOCIter | PRPCacheCIter |
typedef bmi::multi_index_container < Dakota::ParamResponsePair, bmi::indexed_by < bmi::ordered_unique < bmi::tag< ordered > , bmi::const_mem_fun < Dakota::ParamResponsePair, int,&Dakota::ParamResponsePair::eval_id > >, bmi::hashed_non_unique < bmi::tag< hashed > , bmi::identity < Dakota::ParamResponsePair > , partial_prp_hash, partial_prp_equality > > > | PRPMultiIndexQueue |
Boost Multi-Index Container for queueing ParamResponsePairs. | |
typedef PRPMultiIndexQueue | PRPQueue |
typedef PRPQueue::index_iterator < ordered >::type | PRPQueueOIter |
typedef PRPQueue::index_const_iterator < ordered >::type | PRPQueueOCIter |
typedef PRPQueue::index_iterator < hashed >::type | PRPQueueHIter |
typedef PRPQueue::index_const_iterator < hashed >::type | PRPQueueHCIter |
typedef PRPQueueOIter | PRPQueueIter |
typedef PRPQueueOCIter | PRPQueueCIter |
Enumerations | |
enum | { COBYLA, DIRECT, EA, MS, PS, SW } |
enum | { OBJECTIVE, INEQUALITY_CONSTRAINT, EQUALITY_CONSTRAINT } |
define algebraic function types | |
enum | { SILENT_OUTPUT, QUIET_OUTPUT, NORMAL_OUTPUT, VERBOSE_OUTPUT, DEBUG_OUTPUT } |
enum | { STD_NORMAL_U, ASKEY_U, EXTENDED_U } |
enum | { NO_INT_REFINE, IS, AIS, MMAIS } |
enum | { PROBABILITIES, RELIABILITIES, GEN_RELIABILITIES } |
enum | { IGNORE_RANKS, SET_RANKS, GET_RANKS, SET_GET_RANKS } |
enum | { UNCERTAIN, UNCERTAIN_UNIFORM, ACTIVE, ACTIVE_UNIFORM, ALL, ALL_UNIFORM } |
enum | { MV, AMV_X, AMV_U, AMV_PLUS_X, AMV_PLUS_U, TANA_X, TANA_U, NO_APPROX } |
enum | { BREITUNG, HOHENRACK, HONG } |
enum | { EGRA_X, EGRA_U } |
enum | { ORIGINAL_PRIMARY, SINGLE_OBJECTIVE, LAGRANGIAN_OBJECTIVE, AUGMENTED_LAGRANGIAN_OBJECTIVE } |
enum | { NO_CONSTRAINTS, LINEARIZED_CONSTRAINTS, ORIGINAL_CONSTRAINTS } |
enum | { NO_RELAX, HOMOTOPY, COMPOSITE_STEP } |
enum | { PENALTY_MERIT, ADAPTIVE_PENALTY_MERIT, LAGRANGIAN_MERIT, AUGMENTED_LAGRANGIAN_MERIT } |
enum | { FILTER, TR_RATIO } |
enum | { SCALE_NONE, SCALE_VALUE, SCALE_LOG } |
enum | { CDV, LINEAR, NONLIN, FN_LSQ } |
enum | { DISALLOW, TARGET, BOUNDS } |
enum | { EMPTY, MERGED_ALL, MIXED_ALL, MERGED_DISTINCT_DESIGN, MERGED_DISTINCT_UNCERTAIN, MERGED_DISTINCT_ALEATORY_UNCERTAIN, MERGED_DISTINCT_EPISTEMIC_UNCERTAIN, MERGED_DISTINCT_STATE, MIXED_DISTINCT_DESIGN, MIXED_DISTINCT_UNCERTAIN, MIXED_DISTINCT_ALEATORY_UNCERTAIN, MIXED_DISTINCT_EPISTEMIC_UNCERTAIN, MIXED_DISTINCT_STATE } |
enum | { CONTINUOUS_DESIGN, DISCRETE_DESIGN_RANGE, DISCRETE_DESIGN_SET_INT, DISCRETE_DESIGN_SET_REAL, NORMAL_UNCERTAIN, LOGNORMAL_UNCERTAIN, UNIFORM_UNCERTAIN, LOGUNIFORM_UNCERTAIN, TRIANGULAR_UNCERTAIN, EXPONENTIAL_UNCERTAIN, BETA_UNCERTAIN, GAMMA_UNCERTAIN, GUMBEL_UNCERTAIN, FRECHET_UNCERTAIN, WEIBULL_UNCERTAIN, HISTOGRAM_BIN_UNCERTAIN, POISSON_UNCERTAIN, BINOMIAL_UNCERTAIN, NEGATIVE_BINOMIAL_UNCERTAIN, GEOMETRIC_UNCERTAIN, HYPERGEOMETRIC_UNCERTAIN, HISTOGRAM_POINT_UNCERTAIN, INTERVAL_UNCERTAIN, CONTINUOUS_STATE, DISCRETE_STATE_RANGE, DISCRETE_STATE_SET_INT, DISCRETE_STATE_SET_REAL } |
enum | var_t { VAR_x1, VAR_x2, VAR_x3, VAR_b, VAR_h, VAR_P, VAR_M, VAR_Y, VAR_w, VAR_t, VAR_R, VAR_E, VAR_X, VAR_Fs, VAR_P1, VAR_P2, VAR_P3, VAR_B, VAR_D, VAR_H, VAR_F0, VAR_d } |
enumeration of possible variable types (to index to names) | |
enum | driver_t { NO_DRIVER = 0, CANTILEVER_BEAM, MOD_CANTILEVER_BEAM, CYLINDER_HEAD, EXTENDED_ROSENBROCK, GENERALIZED_ROSENBROCK, ROSENBROCK, LOGNORMAL_RATIO, MULTIMODAL, PLUGIN_ROSENBROCK, PLUGIN_TEXT_BOOK, SHORT_COLUMN, SOBOL_RATIONAL, SOBOL_G_FUNCTION, SOBOL_ISHIGAMI, STEEL_COLUMN_COST, STEEL_COLUMN_PERFORMANCE, TEXT_BOOK, TEXT_BOOK1, TEXT_BOOK2, TEXT_BOOK3, TEXT_BOOK_OUU, SALINAS, MODELCENTER, MATLAB, PYTHON } |
enumeration of possible driver types (to index to names) | |
enum | local_data_t { VARIABLES_MAP = 1, VARIABLES_VECTOR = 2 } |
enumeration for how local variables are stored (values must employ a bit representation) | |
enum | { sFTW_F, sFTW_SL, sFTW_D, sFTW_DP, sFTW_DNR, sFTW_O, sFTW_NS } |
enum | { sFTWret_OK, sFTWret_quit, sFTWret_skipdir, sFTWret_Follow, sFTWret_mallocfailure } |
enum | { SETUP_MODEL, SETUP_USERFUNC } |
enum | { CAUVar_normal = 0, CAUVar_lognormal = 1, CAUVar_uniform = 2, CAUVar_loguniform = 3, CAUVar_triangular = 4, CAUVar_exponential = 5, CAUVar_beta = 6, CAUVar_gamma = 7, CAUVar_gumbel = 8, CAUVar_frechet = 9, CAUVar_weibull = 10, CAUVar_histogram_bin = 11, CAUVar_Nkinds = 12 } |
enum | { DAUIVar_poisson = 0, DAUIVar_binomial = 1, DAUIVar_negative_binomial = 2, DAUIVar_geometric = 3, DAUIVar_hypergeometric = 4, DAUIVar_Nkinds = 5 } |
enum | { DAURVar_histogram_point = 0, DAURVar_Nkinds = 1 } |
enum | { CEUVar_interval = 0, CEUVar_Nkinds = 1 } |
enum | { DiscSetVar_design_set_int = 0, DiscSetVar_design_set_real = 1, DiscSetVar_state_set_int = 2, DiscSetVar_state_set_real = 3, DiscSetVar_Nkinds = 4 } |
enum | { N_VLS = 4 } |
enum | { NO_EMULATOR, STOCHASTIC_EXPANSION, GAUSSIAN_PROCESS } |
enum | CG_UPDATETYPE { CG_STEEPEST, CG_FLETCHER_REEVES, CG_POLAK_RIBIERE, CG_POLAK_RIBIERE_PLUS, CG_HESTENES_STIEFEL } |
NonlinearCG update options. | |
enum | CG_LINESEARCHTYPE { CG_FIXED_STEP, CG_LS_SIMPLE, CG_LS_BRENT, CG_LS_WOLFE } |
NonlinearCG linesearch options. | |
enum | { LIST = 1, VECTOR_SV, VECTOR_FP, CENTERED, MULTIDIM } |
enum | { ESTIMATE_ORDER = 1, CONVERGE_ORDER, CONVERGE_QOI } |
enum | EvalType { NLFEvaluator, CONEvaluator } |
enumeration for the type of evaluator function | |
enum | { TH_SILENT_OUTPUT, TH_QUIET_OUTPUT, TH_NORMAL_OUTPUT, TH_VERBOSE_OUTPUT, TH_DEBUG_OUTPUT } |
Functions | |
static const char * | basename (const char *s) |
return name of s, stripped of any leading path information | |
static void | cleanup_and_abort (const std::string &resname) |
output error message about results file and call abort | |
CommandShell & | flush (CommandShell &shell) |
convenient shell manipulator function to "flush" the shell | |
bool | operator== (const ActiveSet &set1, const ActiveSet &set2) |
equality operator for ActiveSet | |
std::istream & | operator>> (std::istream &s, ActiveSet &set) |
std::istream extraction operator for ActiveSet. Calls read(std::istream&). | |
std::ostream & | operator<< (std::ostream &s, const ActiveSet &set) |
std::ostream insertion operator for ActiveSet. Calls write(std::istream&). | |
BiStream & | operator>> (BiStream &s, ActiveSet &set) |
BiStream extraction operator for ActiveSet. Calls read(BiStream&). | |
BoStream & | operator<< (BoStream &s, const ActiveSet &set) |
BoStream insertion operator for ActiveSet. Calls write(BoStream&). | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, ActiveSet &set) |
MPIUnpackBuffer extraction operator for ActiveSet. Calls read(MPIUnpackBuffer&). | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const ActiveSet &set) |
MPIPackBuffer insertion operator for ActiveSet. Calls write(MPIPackBuffer&). | |
bool | operator!= (const ActiveSet &set1, const ActiveSet &set2) |
inequality operator for ActiveSet | |
template<class ArrayT > | |
void | array_read (ArrayT &v, BiStream &s) |
Read an array from BiStream, s. | |
template<class ArrayT > | |
void | array_write (const ArrayT &v, BoStream &s) |
Write an array to BoStream, s. | |
template<class ArrayT > | |
BiStream & | operator>> (BiStream &s, ArrayT &data) |
global BiStream extraction operator for generic "array" container | |
template<class ArrayT > | |
BoStream & | operator<< (BoStream &s, const ArrayT &data) |
global BoStream insertion operator for generic "array" container | |
std::istream & | operator>> (std::istream &s, Constraints &con) |
std::istream extraction operator for Constraints | |
std::ostream & | operator<< (std::ostream &s, const Constraints &con) |
std::ostream insertion operator for Constraints | |
bool | interface_id_compare (const Interface &interface, const void *id) |
global comparison function for Interface | |
NIDR_KWlib * | nidr_lib_record (void *, const char *) |
void * | nidr_dlopen (const char *) |
static p_vf | Lib_load (SharedLib *L, int k) |
void | DOT (int *info, int *ngotoz, int *method, int *iprint, int *ndv, int *ncon, double *x, double *xl, double *xu, double *obj, int *minmax, double *g, double *rprm, int *iprm, double *wk, int *nrwk, int *iwk, int *nriwk) |
void | DOT510 (int *ndv, int *ncon, int *ncola, int *method, int *nrwk, int *nriwk, int *nrb, int *ngmax, double *xl, double *xu) |
void | NPSOL (int *n, int *nclin, int *ncnln, int *lda, int *ldju, int *ldr, double *a, double *bl, double *bu, p_vf funcon, p_vf funobj, int *inform, int *iter, int *istate, double *c, double *cjacu, double *clamda, double *objf, double *gradu, double *r, double *x, int *iw, int *leniw, double *w, int *lenw) |
void | NLSSOL (int *m, int *n, int *nclin, int *ncnln, int *lda, int *ldcju, int *ldfju, int *ldr, double *a, double *bl, double *bu, p_vf funcon, p_vf funobj, int *inform, int *iter, int *istate, double *c, double *cjacu, double *y, double *f, double *fjacu, double *clamda, double *objf, double *r, double *x, int *iw, int *leniw, double *w, int *lenw) |
void | NPOPTN2 (char *string, size_t string_len) |
void | NLPQLP (int *l, int *m, int *me, int *mmax, int *n, int *nmax, int *mnn2, double *x, double *f, double *g, double *df, double *dg, double *u, double *xl, double *xu, double *c, double *d, double *acc, double *accqp, double *stpmin, int *maxfun, int *maxit, int *max_nm, double *tol_nm, int *iprint, int *mode, int *iout, int *ifail, double *wa, int *lwa, int *kwa, int *lkwa, int *active, int *lactiv, int *lql, p_vf qpsolve) |
void | QL (int *m, int *me, int *mmax, int *n, int *nmax, int *mnn, double *c, double *d, double *a, double *b, double *xl, double *xu, double *x, double *u, double *eps, int *mode, int *iout, int *ifail, int *iprint, double *war, int *lwar, int *iwar, int *liwar) |
static void | not_available (const char *what) |
static DOTOptimizer * | no_DOT (Model &model) |
static DOTOptimizer * | no_DOT1 (NoDBBaseConstructor, Model &model) |
static JEGAOptimizer * | no_JEGA (Model &model) |
static NLPQLPOptimizer * | no_NLPQL (Model &model) |
static NLPQLPOptimizer * | no_NLPQL1 (NoDBBaseConstructor, Model &model) |
static NPSOLOptimizer * | no_NPSOL (Model &model) |
static NPSOLOptimizer * | no_NPSOL1 (NoDBBaseConstructor, Model &model) |
static NPSOLOptimizer * | no_NPSOL2 (Model &model, const int &derivative_level, const Real &conv_tol) |
static NPSOLOptimizer * | no_NPSOL3 (const RealVector &initial_point, const RealVector &var_lower_bnds, const RealVector &var_upper_bnds, const RealMatrix &lin_ineq_coeffs, const RealVector &lin_ineq_lower_bnds, const RealVector &lin_ineq_upper_bnds, const RealMatrix &lin_eq_coeffs, const RealVector &lin_eq_targets, const RealVector &nonlin_ineq_lower_bnds, const RealVector &nonlin_ineq_upper_bnds, const RealVector &nonlin_eq_targets, void(*user_obj_eval)(int &, int &, double *, double &, double *, int &), void(*user_con_eval)(int &, int &, int &, int &, int *, double *, double *, double *, int &), const int &derivative_level, const Real &conv_tol) |
static NLSSOLLeastSq * | no_NLSSOL (Model &model) |
static NLSSOLLeastSq * | no_NLSSOL1 (NoDBBaseConstructor, Model &model) |
bool | method_id_compare (const Iterator &iterator, const void *id) |
global comparison function for Iterator | |
bool | model_id_compare (const Model &model, const void *id) |
global comparison function for Model | |
bool | operator== (const ResponseRep &rep1, const ResponseRep &rep2) |
equality operator for ResponseRep | |
bool | responses_id_compare (const Response &resp, const void *id) |
global comparison function for Response | |
std::istream & | operator>> (std::istream &s, Response &response) |
std::istream extraction operator for Response. Calls read(std::istream&). | |
std::ostream & | operator<< (std::ostream &s, const Response &response) |
std::ostream insertion operator for Response. Calls write(std::ostream&). | |
BiStream & | operator>> (BiStream &s, Response &response) |
BiStream extraction operator for Response. Calls read(BiStream&). | |
BoStream & | operator<< (BoStream &s, const Response &response) |
BoStream insertion operator for Response. Calls write(BoStream&). | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, Response &response) |
MPIUnpackBuffer extraction operator for Response. Calls read(MPIUnpackBuffer&). | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const Response &response) |
MPIPackBuffer insertion operator for Response. Calls write(MPIPackBuffer&). | |
bool | operator== (const Response &resp1, const Response &resp2) |
equality operator for Response | |
bool | operator!= (const Response &resp1, const Response &resp2) |
inequality operator for Response | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const String &data) |
Reads String from buffer. | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, String &data) |
Writes String to buffer. | |
String | operator+ (const String &s1, const String &s2) |
Concatenate two Strings and return the resulting String. | |
String | operator+ (const char *s1, const String &s2) |
Append a String to a char* and return the resulting String. | |
String | operator+ (const String &s1, const char *s2) |
Append a char* to a String and return the resulting String. | |
String | operator+ (const std::string &s1, const String &s2) |
Append a String to a std::string and return the resulting String. | |
String | operator+ (const String &s1, const std::string &s2) |
Append a std::string to a String and return the resulting String. | |
String | toUpper (const String &str) |
Returns a String converted to upper case. Calls String::upper(). | |
String | toLower (const String &str) |
Returns a String converted to lower case. Calls String::lower(). | |
bool | operator== (const Variables &vars1, const Variables &vars2) |
equality operator for Variables | |
bool | binary_equal_to (const Variables &vars1, const Variables &vars2) |
binary_equal_to (since 'operator==' is not suitable for boost/hashed lookup) | |
std::size_t | hash_value (const Variables &vars) |
hash_value for Variables - required by the new BMI hash_set of PRPairs | |
bool | variables_id_compare (const Variables &vars, const void *id) |
global comparison function for Variables | |
std::istream & | operator>> (std::istream &s, Variables &vars) |
std::istream extraction operator for Variables. | |
std::ostream & | operator<< (std::ostream &s, const Variables &vars) |
std::ostream insertion operator for Variables. | |
BiStream & | operator>> (BiStream &s, Variables &vars) |
BiStream extraction operator for Variables. | |
BoStream & | operator<< (BoStream &s, const Variables &vars) |
BoStream insertion operator for Variables. | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, Variables &vars) |
MPIUnpackBuffer extraction operator for Variables. | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const Variables &vars) |
MPIPackBuffer insertion operator for Variables. | |
bool | operator!= (const Variables &vars1, const Variables &vars2) |
inequality operator for Variables | |
template<class T > | |
std::ostream & | operator<< (std::ostream &s, const std::set< T > &data) |
global std::ostream insertion operator for std::set | |
template<class T > | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, std::set< T > &data) |
global MPIUnpackBuffer extraction operator for std::set | |
template<class T > | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const std::set< T > &data) |
global MPIPackBuffer insertion operator for std::set | |
template<typename OrdinalType , typename ScalarType > | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &data) |
global MPIPackBuffer insertion operator for Teuchos::SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const Teuchos::SerialDenseMatrix< OrdinalType, ScalarType > &data) |
global MPIPackBuffer insertion operator for Teuchos::SerialDenseMatrix | |
template<typename OrdinalType , typename ScalarType > | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const Teuchos::SerialSymDenseMatrix< OrdinalType, ScalarType > &data) |
global MPIPackBuffer insertion operator for Teuchos::SerialSymDenseMatrix | |
template<typename OrdinalType , typename ScalarType > | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &data) |
global MPIUnpackBuffer extraction operator for Teuchos::SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, Teuchos::SerialDenseMatrix< OrdinalType, ScalarType > &data) |
global MPIUnpackBuffer extraction operator for Teuchos::SerialDenseMatrix | |
template<typename OrdinalType , typename ScalarType > | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, Teuchos::SerialSymDenseMatrix< OrdinalType, ScalarType > &data) |
global MPIUnpackBuffer extraction operator for Teuchos::SerialSymDenseMatrix | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data (std::istream &s, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v) |
standard istream extraction operator for full SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data (std::istream &s, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, StringMultiArray &label_array) |
standard istream extraction operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data (std::istream &s, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, StringMultiArrayView label_array) |
standard istream extraction operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data_partial (std::istream &s, size_t start_index, size_t num_items, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v) |
standard istream extraction operator for partial SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data_partial (std::istream &s, size_t start_index, size_t num_items, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, StringMultiArray &label_array) |
standard istream extraction operator for partial SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data_partial (std::istream &s, size_t start_index, size_t num_items, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, StringMultiArrayView label_array) |
standard istream extraction operator for partial SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data_tabular (std::istream &s, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v) |
tabular istream extraction operator for full SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data_partial_tabular (std::istream &s, size_t start_index, size_t num_items, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v) |
tabular istream extraction operator for partial SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data_annotated (std::istream &s, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, StringMultiArray &label_array) |
annotated istream extraction operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data_annotated (std::istream &s, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, StringMultiArrayView label_array) |
annotated istream extraction operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data (std::ostream &s, const ScalarType *v, OrdinalType len) |
standard ostream insertion operator for full SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data (std::ostream &s, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v) |
standard ostream insertion operator for full SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data (std::ostream &s, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, const StringMultiArray &label_array) |
standard ostream insertion operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data (std::ostream &s, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, StringMultiArrayConstView &label_array) |
standard ostream insertion operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data (std::ostream &s, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, const StringArray &label_array) |
standard ostream insertion operator for full SerialDenseVector with alternate labels | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data_aprepro (std::ostream &s, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, const StringMultiArray &label_array) |
aprepro ostream insertion operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data_partial (std::ostream &s, size_t start_index, size_t num_items, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v) |
standard ostream insertion operator for partial SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data_partial (std::ostream &s, size_t start_index, size_t num_items, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, const StringMultiArray &label_array) |
standard ostream insertion operator for partial SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data_partial_aprepro (std::ostream &s, size_t start_index, size_t num_items, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, const StringMultiArray &label_array) |
aprepro ostream insertion operator for partial SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data_annotated (std::ostream &s, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, const StringMultiArray &label_array) |
annotated ostream insertion operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data_tabular (std::ostream &s, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v) |
tabular ostream insertion operator for full SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data_partial_tabular (std::ostream &s, size_t start_index, size_t num_items, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v) |
tabular ostream insertion operator for partial SerialDenseVector | |
void | write_data_tabular (std::ostream &s, StringMultiArrayConstView ma) |
tabular ostream insertion operator for view of StringMultiArray | |
template<typename OrdinalType , typename ScalarType > | |
std::istream & | operator>> (std::istream &s, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &data) |
global std::istream extraction operator for SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
std::ostream & | operator<< (std::ostream &s, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &data) |
global std::ostream insertion operator for SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data (BiStream &s, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, StringMultiArray &label_array) |
standard binary stream extraction operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data (BiStream &s, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, StringMultiArrayView label_array) |
standard binary stream extraction operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data (BoStream &s, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, const StringMultiArray &label_array) |
standard binary stream insertion operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data (MPIUnpackBuffer &s, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, StringMultiArray &label_array) |
standard MPI buffer extraction operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data (MPIUnpackBuffer &s, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, StringMultiArrayView label_array) |
standard MPI buffer extraction operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data (MPIPackBuffer &s, const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &v, const StringMultiArray &label_array) |
standard MPI buffer insertion operator for full SerialDenseVector with labels | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data (std::istream &s, std::vector< Teuchos::SerialDenseVector< OrdinalType, ScalarType > > &va) |
standard istream extraction operator for std::vector of SerialDenseVectors | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data (std::istream &s, Teuchos::SerialSymDenseMatrix< OrdinalType, ScalarType > &m) |
standard istream extraction operator for SerialSymDenseMatrix | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data (BiStream &s, Teuchos::SerialSymDenseMatrix< OrdinalType, ScalarType > &m) |
standard binary stream extraction operator for SerialSymDenseMatrix | |
template<typename OrdinalType , typename ScalarType > | |
void | read_data (MPIUnpackBuffer &s, Teuchos::SerialSymDenseMatrix< OrdinalType, ScalarType > &m) |
standard MPI buffer extraction operator for SerialSymDenseMatrix | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data (std::ostream &s, const Teuchos::SerialSymDenseMatrix< OrdinalType, ScalarType > &m, bool brackets, bool row_rtn, bool final_rtn) |
formatted ostream insertion operator for SerialSymDenseMatrix | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data (BoStream &s, const Teuchos::SerialSymDenseMatrix< OrdinalType, ScalarType > &m) |
standard binary stream insertion operator for SerialSymDenseMatrix | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data (MPIPackBuffer &s, const Teuchos::SerialSymDenseMatrix< OrdinalType, ScalarType > &m) |
standard MPI buffer insertion operator for SerialSymDenseMatrix | |
template<typename OrdinalType , typename ScalarType > | |
void | write_data (std::ostream &s, const Teuchos::SerialDenseMatrix< OrdinalType, ScalarType > &m, bool brackets, bool row_rtn, bool final_rtn) |
formatted ostream insertion operator for SerialSymDenseMatrix | |
template<typename OrdinalType , typename ScalarType > | |
void | write_col_vector_trans (std::ostream &s, OrdinalType col, OrdinalType num_items, bool brackets, bool break_line, bool final_rtn, const Teuchos::SerialDenseMatrix< OrdinalType, ScalarType > &sdm) |
standard MPI buffer insertion operator for SerialSymDenseMatrix | |
template<typename OrdinalType , typename ScalarType > | |
void | write_col_vector_trans (std::ostream &s, OrdinalType col, bool brackets, bool break_line, bool final_rtn, const Teuchos::SerialDenseMatrix< OrdinalType, ScalarType > &sdm) |
ostream insertion operator for a column vector from a SerialDenseMatrix | |
template<typename OStreamType , typename OrdinalType , typename ScalarType > | |
void | write_col_vector_trans (OStreamType &s, OrdinalType col, OrdinalType num_items, const Teuchos::SerialDenseMatrix< OrdinalType, ScalarType > &sdm) |
ostream insertion operator for a column vector from a SerialDenseMatrix | |
template<typename OStreamType , typename OrdinalType , typename ScalarType > | |
void | write_col_vector_trans (OStreamType &s, OrdinalType col, const Teuchos::SerialDenseMatrix< OrdinalType, ScalarType > &sdm) |
ostream insertion operator for a column vector from a SerialDenseMatrix | |
template<typename IStreamType , typename OrdinalType , typename ScalarType > | |
void | read_col_vector_trans (IStreamType &s, OrdinalType col, Teuchos::SerialDenseMatrix< OrdinalType, ScalarType > &sdm) |
istream extraction operator for a column vector from a SerialDenseMatrix | |
template<class ArrayT > | |
void | array_read (ArrayT &v, std::istream &s) |
read array from std::istream | |
template<class ArrayT > | |
void | array_write (const ArrayT &v, std::ostream &s) |
write array to std::ostream | |
template<class ListT > | |
void | list_write (const ListT &l, std::ostream &s) |
write list to std::ostream | |
template<class T > | |
std::istream & | operator>> (std::istream &s, std::vector< T > &data) |
global std::istream extraction operator for std::vector | |
template<class T > | |
std::ostream & | operator<< (std::ostream &s, const std::vector< T > &data) |
global std::ostream insertion operator for std::vector | |
template<class T > | |
std::ostream & | operator<< (std::ostream &s, const std::list< T > &data) |
global std::ostream insertion operator for std::list | |
template<class ArrayT > | |
void | array_write (std::ostream &s, const ArrayT &v, const std::vector< String > &label_array) |
write array to std::ostream with labels | |
template<class ArrayT > | |
void | array_write_aprepro (std::ostream &s, const ArrayT &v, const std::vector< String > &label_array) |
write array to std::ostream (APREPRO format) | |
template<class ArrayT > | |
void | array_write_annotated (const ArrayT &v, std::ostream &s, bool write_len) |
Write array to ostream as a row vector; precede with length if write_len = true. | |
bool | operator== (const ShortArray &dsa1, const ShortArray &dsa2) |
equality operator for ShortArray | |
bool | operator== (const StringArray &dsa1, const StringArray &dsa2) |
equality operator for StringArray | |
bool | operator== (const SizetArray &sa, SizetMultiArrayConstView smav) |
equality operator for SizetArray and SizetMultiArrayConstView | |
void | copy_data (const RealSymMatrix &rsdm, NEWMAT::SymmetricMatrix &sm) |
copy RealSymMatrix to NEWMAT::SymmetricMatrix | |
void | copy_data (const RealMatrix &rdm, NEWMAT::Matrix &m) |
copy RealMatrix to NEWMAT::Matrix | |
void | copy_data (const NEWMAT::ColumnVector &cv, RealVector &rdv) |
copy NEWMAT::ColumnVector to RealVector | |
void | copy_data (const Real *rdv, const int num_items, NEWMAT::ColumnVector &cv) |
copy Real* (column of Teuchos_SerialDenseMatrix) to NEWMAT::ColumnVector | |
void | copy_data (const RealVector &rdv, NEWMAT::ColumnVector &cv) |
copy RealVector to NEWMAT::ColumnVector | |
void | copy_data (const DDaceSamplePoint &dsp, RealVector &rdv) |
copy DDACE point to RealVector | |
void | copy_data (const std::vector< DDaceSamplePoint > &dspa, RealVectorArray &rdva) |
copy DDACE point array to RealVectorArray | |
void | copy_data (const std::vector< DDaceSamplePoint > &dspa, Real *ptr, const int ptr_len) |
copy DDACE point array to Real* | |
bool | operator== (const IntArray &dia1, const IntArray &dia2) |
equality operator for IntArray | |
bool | operator!= (const IntArray &dia1, const IntArray &dia2) |
inequality operator for IntArray | |
bool | operator!= (const ShortArray &dsa1, const ShortArray &dsa2) |
inequality operator for ShortArray | |
bool | operator!= (const StringArray &dsa1, const StringArray &dsa2) |
inequality operator for StringArray | |
bool | operator!= (const SizetArray &sa, SizetMultiArrayConstView smav) |
inequality operator for StringArray | |
void | build_label (String &label, const String &root_label, size_t tag) |
create a label by appending a numerical tag to the root_label | |
void | build_labels (StringArray &label_array, const String &root_label) |
create an array of labels by tagging root_label for each entry in label_array. Uses build_label(). | |
void | build_labels (StringMultiArray &label_array, const String &root_label) |
create an array of labels by tagging root_label for each entry in label_array. Uses build_label(). | |
void | build_labels_partial (StringArray &label_array, const String &root_label, size_t start_index, size_t num_items) |
create a partial array of labels by tagging root_label for a subset of entries in label_array. Uses build_label(). | |
void | copy_row_vector (const RealMatrix &m, RealMatrix::ordinalType i, std::vector< Real > &row) |
Copies a row of a Teuchos_SerialDenseMatrix<int,Real> to std::vector<Real> | |
template<class T > | |
void | copy_data (const std::vector< T > &dbv, T *ptr, const int ptr_len) |
copy Array<T> to T* | |
template<typename OrdinalType , typename ScalarType > | |
void | copy_data (const std::vector< Teuchos::SerialDenseVector< OrdinalType, ScalarType > > &sdva, ScalarType *ptr, const OrdinalType ptr_len, const String &ptr_type) |
copy Array<Teuchos::SerialDenseVector<OT,ST> > to ST* | |
template<typename OrdinalType , typename ScalarType > | |
void | copy_data (const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv, Teuchos::SerialDenseMatrix< OrdinalType, ScalarType > &sdm, OrdinalType nr, OrdinalType nc) |
copy Teuchos::SerialDenseVector<OT,ST> to Teuchos::SerialDenseMatrix<OT,ST> | |
template<class T > | |
void | copy_data (const std::list< T > &dl, std::vector< T > &da) |
copy std::list<T> to std::vector<T> | |
template<class T > | |
void | copy_data (const std::list< T > &dl, std::vector< std::vector< T > > &d2a, size_t num_a, size_t a_len) |
copy std::list<T> to std::vector<std::vector<T> > | |
template<class T > | |
void | copy_data (const std::vector< std::vector< T > > &d2a, std::vector< T > &da) |
copy std::vector<vector<T> > to std::vector<T>(unroll vecOfvecs into vector) | |
template<class T > | |
void | copy_data (const std::map< int, T > &im, std::vector< T > &da) |
copy map<int, T> to std::vector<T> (discard integer keys) | |
template<typename OrdinalType , typename ScalarType > | |
void | copy_data (const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv1, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv2) |
copy Teuchos::SerialDenseVector<OrdinalType, ScalarType> to same (used in place of operator= when a deep copy of a vector view is needed) | |
template<typename OrdinalType , typename ScalarType > | |
void | copy_data (const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv, std::vector< ScalarType > &da) |
copy Teuchos::SerialDenseVector<OrdinalType, ScalarType> to std::vector<ScalarType> | |
template<typename OrdinalType , typename ScalarType > | |
void | copy_data (const std::vector< ScalarType > &da, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv) |
copy Array<ScalarType> to Teuchos::SerialDenseVector<OrdinalType, ScalarType> | |
template<typename OrdinalType , typename ScalarType > | |
void | copy_data (const ScalarType *ptr, const OrdinalType ptr_len, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv) |
copy ScalarType* to Teuchos::SerialDenseVector<OrdinalType, ScalarType> | |
template<typename OrdinalType , typename ScalarType > | |
void | copy_data (const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv, ScalarType *ptr, const OrdinalType ptr_len) |
copy ScalarType* to Teuchos::SerialDenseVector<OrdinalType, ScalarType> | |
template<typename OrdinalType , typename ScalarType > | |
void | copy_data (const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv, std::vector< Teuchos::SerialDenseVector< OrdinalType, ScalarType > > &sdva, OrdinalType num_vec, OrdinalType vec_len) |
copy SerialDenseVector<> to Array<SerialDenseVector<> > | |
template<typename OrdinalType , typename ScalarType > | |
void | copy_data_partial (const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv1, OrdinalType start_index1, OrdinalType num_items, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv2) |
copy portion of first SerialDenseVector to all of second SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
void | copy_data_partial (const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv1, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv2, OrdinalType start_index2) |
copy all of first SerialDenseVector to portion of second SerialDenseVector | |
template<typename OrdinalType , typename ScalarType > | |
void | copy_data_partial (const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv1, OrdinalType start_index1, OrdinalType num_items, Teuchos::SerialDenseVector< OrdinalType, ScalarType > &sdv2, OrdinalType start_index2) |
copy portion of first SerialDenseVector to portion of second SerialDenseVector | |
template<class T > | |
void | copy_data_partial (const std::vector< T > &da1, size_t start_index1, size_t num_items, std::vector< T > &da2) |
copy portion of first Array<T> to all of second Array<T> | |
template<class T > | |
void | copy_data_partial (const std::vector< T > &da1, std::vector< T > &da2, size_t start_index2) |
copy all of first Array<T> to portion of second Array<T> | |
template<class T > | |
void | copy_data_partial (const std::vector< T > &da, boost::multi_array< T, 1 > &bma, size_t start_index_bma) |
copy all of first Array<T> to portion of boost::multi_array<T, 1> | |
template<class T > | |
void | copy_data_partial (const std::vector< T > &da1, size_t start_index1, size_t num_items, std::vector< T > &da2, size_t start_index2) |
copy portion of first Array<T> to portion of second Array<T> | |
void | merge_data_partial (const IntVector &d_array, RealVector &m_array, size_t start_index_ma) |
aggregate continuous and discrete arrays into a single merged array | |
template<typename OrdinalType , typename ScalarType > | |
const ScalarType & | set_index_to_value (OrdinalType index, const std::set< ScalarType > &values) |
retrieve the set value corresponding to the passed index | |
template<typename ScalarType > | |
size_t | set_value_to_index (const ScalarType &value, const std::set< ScalarType > &values) |
calculate the set index corresponding to the passed value | |
template<typename OrdinalType , typename ScalarType > | |
void | x_y_pairs_to_x_set (const Teuchos::SerialDenseVector< OrdinalType, ScalarType > &xy_pairs, std::set< ScalarType > &x_set) |
convert a SerialDenseVector of head-to-tail (x,y) pairs into a std::set of (x), discarding the y values | |
template<typename MultiArrayType , typename DataType > | |
size_t | find_index (const MultiArrayType &a, const DataType &search_data) |
template<typename MultiArrayType , typename DakArrayType > | |
void | copy_data (const MultiArrayType &ma, DakArrayType &da) |
template<class T > | |
size_t | find_index (const boost::multi_array< T, 1 > &bma, const T &search_data) |
compute the index of an entry within a boost::multi_array | |
size_t | find_index (SizetMultiArrayConstView bmacv, size_t search_data) |
compute the index of an entry within a boost::multi_array view | |
size_t | find_index (StringMultiArrayConstView bmacv, const String &search_data) |
compute the index of an entry within a boost::multi_array view | |
template<class ListT > | |
ListT::size_type | find_index (const ListT &l, const typename ListT::value_type &val) |
compute the index of an entry within a std::list | |
void | copy_data (SizetMultiArrayConstView ma, SizetArray &da) |
copy boost::multi_array view to Array | |
void | copy_data (StringMultiArrayConstView ma, StringArray &da) |
copy boost::multi_array view to Array | |
template<typename DakContainerType > | |
bool | contains (const DakContainerType &v, const typename DakContainerType::value_type &val) |
return true if the item val appears in container v | |
template<class ListT > | |
ListT::size_type | count_if (const ListT &l, bool(*test_fn)(const typename ListT::value_type &, const std::string &), const std::string &test_fn_data) |
count the number of elements in the list satisfying the predicate test_fn w.r.t. the passed test_fn_data | |
template<class ListT > | |
ListT::const_iterator | find_if (const ListT &c, bool(*test_fn)(const typename ListT::value_type &, const std::string &), const std::string &test_fn_data) |
return an iterator to the first list element satisfying the predicate test_fn w.r.t. the passed test_fn_data; end if not found | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const DataInterface &data) |
MPIPackBuffer insertion operator for DataInterface. | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, DataInterface &data) |
MPIUnpackBuffer extraction operator for DataInterface. | |
std::ostream & | operator<< (std::ostream &s, const DataInterface &data) |
std::ostream insertion operator for DataInterface | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const DataMethod &data) |
MPIPackBuffer insertion operator for DataMethod. | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, DataMethod &data) |
MPIUnpackBuffer extraction operator for DataMethod. | |
std::ostream & | operator<< (std::ostream &s, const DataMethod &data) |
std::ostream insertion operator for DataMethod | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const DataModel &data) |
MPIPackBuffer insertion operator for DataModel. | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, DataModel &data) |
MPIUnpackBuffer extraction operator for DataModel. | |
std::ostream & | operator<< (std::ostream &s, const DataModel &data) |
std::ostream insertion operator for DataModel | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const DataResponses &data) |
MPIPackBuffer insertion operator for DataResponses. | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, DataResponses &data) |
MPIUnpackBuffer extraction operator for DataResponses. | |
std::ostream & | operator<< (std::ostream &s, const DataResponses &data) |
std::ostream insertion operator for DataResponses | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const DataStrategy &data) |
MPIPackBuffer insertion operator for DataStrategy. | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, DataStrategy &data) |
MPIUnpackBuffer extraction operator for DataStrategy. | |
std::ostream & | operator<< (std::ostream &s, const DataStrategy &data) |
std::ostream insertion operator for DataStrategy | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const DataVariables &data) |
MPIPackBuffer insertion operator for DataVariables. | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, DataVariables &data) |
MPIUnpackBuffer extraction operator for DataVariables. | |
std::ostream & | operator<< (std::ostream &s, const DataVariables &data) |
std::ostream insertion operator for DataVariables | |
int | salinas_main (int argc, char *argv[], MPI_Comm *comm) |
subroutine interface to SALINAS simulation code | |
int | dlsolver_option (Opt_Info *) |
void | abort_handler (int code) |
global function which handles serial or parallel aborts | |
RealVector const * | continuous_lower_bounds (Optimizer1 *o) |
RealVector const * | continuous_upper_bounds (Optimizer1 *o) |
RealVector const * | nonlinear_ineq_constraint_lower_bounds (Optimizer1 *o) |
RealVector const * | nonlinear_ineq_constraint_upper_bounds (Optimizer1 *o) |
RealVector const * | nonlinear_eq_constraint_targets (Optimizer1 *o) |
RealVector const * | linear_ineq_constraint_lower_bounds (Optimizer1 *o) |
RealVector const * | linear_ineq_constraint_upper_bounds (Optimizer1 *o) |
RealVector const * | linear_eq_constraint_targets (Optimizer1 *o) |
RealMatrix const * | linear_ineq_constraint_coeffs (Optimizer1 *o) |
RealMatrix const * | linear_eq_constraint_coeffs (Optimizer1 *o) |
void | ComputeResponses (Optimizer1 *o, int mode, int n, double *x) |
void | GetFuncs (Optimizer1 *o, int m0, int m1, double *f) |
void | GetGrads (Optimizer1 *o, int m0, int m1, int n, int is, int js, double *g) |
void | GetContVars (Optimizer1 *o, int n, double *x) |
void | SetBestContVars (Optimizer1 *o, int n, double *x) |
void | SetBestRespFns (Optimizer1 *o, int n, double *x) |
void * | dl_constructor (Optimizer1 *, Dakota_funcs *, dl_find_optimum_t *, dl_destructor_t *) |
static RealVector const * | continuous_lower_bounds1 (Optimizer1 *o) |
static RealVector const * | continuous_upper_bounds1 (Optimizer1 *o) |
static RealVector const * | nonlinear_ineq_constraint_lower_bounds1 (Optimizer1 *o) |
static RealVector const * | nonlinear_ineq_constraint_upper_bounds1 (Optimizer1 *o) |
static RealVector const * | nonlinear_eq_constraint_targets1 (Optimizer1 *o) |
static RealVector const * | linear_ineq_constraint_lower_bounds1 (Optimizer1 *o) |
static RealVector const * | linear_ineq_constraint_upper_bounds1 (Optimizer1 *o) |
static RealVector const * | linear_eq_constraint_targets1 (Optimizer1 *o) |
static RealMatrix const * | linear_eq_constraint_coeffs1 (Optimizer1 *o) |
static RealMatrix const * | linear_ineq_constraint_coeffs1 (Optimizer1 *o) |
static void | ComputeResponses1 (Optimizer1 *o, int mode, int n, double *x) |
static void | GetFuncs1 (Optimizer1 *o, int m0, int m1, double *f) |
static void | GetGrads1 (Optimizer1 *o, int m0, int m1, int n, int is, int js, double *g) |
static void | GetContVars1 (Optimizer1 *o, int n, double *x) |
static void | SetBestContVars1 (Optimizer1 *o, int n, double *x) |
static void | SetBestDiscVars1 (Optimizer1 *o, int n, int *x) |
static void | SetBestRespFns1 (Optimizer1 *o, int n, double *x) |
static double | Get_Real1 (Optimizer1 *o, const char *name) |
static int | Get_Int1 (Optimizer1 *o, const char *name) |
static bool | Get_Bool1 (Optimizer1 *o, const char *name) |
static void | find_token (const char *s0, const char **s1, const char **s2, const char **s3) |
const char ** | arg_list_adjust (const char **arg_list, void **a0) |
static std::string | get_dakpath () |
int | not_executable (const char *dname, const char *tdir) |
void | dak_sigcatch (int sig) |
void | start_dakota_heartbeat (int seconds) |
static int | usage (int rc) |
int | main (int argc, char **argv) |
int | sftw (const char *name, int(*fn)(const char *file, const struct stat *, int ftype, int depth, void *v), void *v) |
static int | ftw1 (char *name, size_t namelen, size_t namemaxlen, ftw_fn fn, int, void *v) |
static int | compar (const void *a, const void *b) |
static int | dodir (DIR *dir, char *name, size_t namelen, size_t namemaxlen, ftw_fn fn, int depth, void *v, struct stat *sb) |
int | sftw (const char *name, ftw_fn fn, void *v) |
static int | Symlink (const char *from, const char *to) |
static int | my_recrm (const char *file, const struct stat *sb, int ftype, int depth, void *v) |
int | rec_rmdir (const char *name) |
static void | buf_incr (Buf *b, size_t Lt) |
static int | my_cp (const char *file, const struct stat *sb, int ftype, int depth, void *v) |
int | rec_cp (const char *from, const char *todir, int copy, int flatten, int replace) |
static char * | pathsimp (char *t0) |
static char * | Malloc (size_t L) |
static void | get_npath (int appdrive, char **pnpath) |
void | workdir_adjust (const char *workdir) |
void | workdir_reset () |
void | wd_reset () |
static const char ** | arg_adjust (bool cmd_line_args, std::vector< std::string > &args, const char **av, const char *s) |
static HANDLE * | wait_setup (std::map< pid_t, int > *M, size_t *pn) |
static int | wait_for_one (size_t n, HANDLE *h, int req1, size_t *pi) |
static void | pid_botch () |
template<class ListT > | |
void | removeAt (ListT &l, typename ListT::size_type index) |
Real | getdist (const RealVector &x1, const RealVector &x2) |
Real | mindist (const RealVector &x, const RealMatrix &xset, int except) |
Real | mindistindx (const RealVector &x, const RealMatrix &xset, const IntArray &indx) |
Real | getRmax (const RealMatrix &xset) |
ParallelLibrary | dummy_lib ("dummy") |
dummy ParallelLibrary object used for < mandatory reference initialization when < a real ParallelLibrary instance is < unavailable | |
template<typename T > | |
T | abort_handler_t (int code) |
int | start_grid_computing (char *analysis_driver_script, char *params_file, char *results_file) |
int | stop_grid_computing () |
int | perform_analysis (char *iteration_num) |
template<typename T > | |
string | asstring (const T &val) |
Creates a string from the argument val using an ostringstream. | |
void | run_dakota_data () |
Function to encapsulate the DAKOTA object instantiations for mode 2: direct Data class instantiation. | |
PACKBUF (int, MPI_INT) | |
UNPACKBUF (int, MPI_INT) | |
PACKSIZE (int, MPI_INT) | |
MPIPackBuffer & | operator<< (MPIPackBuffer &buff, const int &data) |
insert an int | |
MPIPackBuffer & | operator<< (MPIPackBuffer &buff, const u_int &data) |
insert a u_int | |
MPIPackBuffer & | operator<< (MPIPackBuffer &buff, const long &data) |
insert a long | |
MPIPackBuffer & | operator<< (MPIPackBuffer &buff, const u_long &data) |
insert a u_long | |
MPIPackBuffer & | operator<< (MPIPackBuffer &buff, const short &data) |
insert a short | |
MPIPackBuffer & | operator<< (MPIPackBuffer &buff, const u_short &data) |
insert a u_short | |
MPIPackBuffer & | operator<< (MPIPackBuffer &buff, const char &data) |
insert a char | |
MPIPackBuffer & | operator<< (MPIPackBuffer &buff, const u_char &data) |
insert a u_char | |
MPIPackBuffer & | operator<< (MPIPackBuffer &buff, const double &data) |
insert a double | |
MPIPackBuffer & | operator<< (MPIPackBuffer &buff, const float &data) |
insert a float | |
MPIPackBuffer & | operator<< (MPIPackBuffer &buff, const bool &data) |
insert a bool | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &buff, int &data) |
extract an int | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &buff, u_int &data) |
extract a u_int | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &buff, long &data) |
extract a long | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &buff, u_long &data) |
extract a u_long | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &buff, short &data) |
extract a short | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &buff, u_short &data) |
extract a u_short | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &buff, char &data) |
extract a char | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &buff, u_char &data) |
extract a u_char | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &buff, double &data) |
extract a double | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &buff, float &data) |
extract a float | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &buff, bool &data) |
extract a bool | |
template<class ContainerT > | |
void | container_read (ContainerT &c, MPIUnpackBuffer &s) |
Read a generic container (vector<T>, list<T>) from MPIUnpackBuffer, s. | |
template<class ContainerT > | |
void | container_write (const ContainerT &c, MPIPackBuffer &s) |
Write a generic container to MPIPackBuffer, s. | |
template<class ContainerT > | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, ContainerT &data) |
global MPIUnpackBuffer extraction operator for generic container | |
template<class ContainerT > | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const ContainerT &data) |
global MPIPackBuffer insertion operator for generic container | |
int | MPIPackSize (const int &data, const int num=1) |
return packed size of an int | |
int | MPIPackSize (const u_int &data, const int num=1) |
return packed size of a u_int | |
int | MPIPackSize (const long &data, const int num=1) |
return packed size of a long | |
int | MPIPackSize (const u_long &data, const int num=1) |
return packed size of a u_long | |
int | MPIPackSize (const short &data, const int num=1) |
return packed size of a short | |
int | MPIPackSize (const u_short &data, const int num=1) |
return packed size of a u_short | |
int | MPIPackSize (const char &data, const int num=1) |
return packed size of a char | |
int | MPIPackSize (const u_char &data, const int num=1) |
return packed size of a u_char | |
int | MPIPackSize (const double &data, const int num=1) |
return packed size of a double | |
int | MPIPackSize (const float &data, const int num=1) |
return packed size of a float | |
int | MPIPackSize (const bool &data, const int num=1) |
return packed size of a bool | |
int | nidr_parse (const char *, FILE *) |
static void | scale_chk (StringArray &ST, RealVector &S, const char *what, const char **univ) |
static void | BuildLabels (StringArray *sa, size_t nsa, size_t n1, size_t n2, const char *stub) |
static int | flist_check (IntList *L, int n, IntArray *iv, const char *what) |
static void | flist_check2 (size_t n, IntArray *iv, const char *what) |
static int | wronglen (size_t n, RealVector *V, const char *what) |
static int | wronglen2 (size_t n, IntVector *V, const char *what) |
static void | Vcopyup (RealVector *V, RealVector *M, size_t i, size_t n) |
static void | Set_rdv (RealVector *V, double d, size_t n) |
static void | Vadj_Normal (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vbgen_normalUnc (DataVariablesRep *dv, size_t i0) |
static void | Vadj_Lognormal (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vbgen_lognormalUnc (DataVariablesRep *dv, size_t i0) |
static void | Vadj_Uniform (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vbgen_uniformUnc (DataVariablesRep *dv, size_t i0) |
static void | Vadj_Loguniform (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vbgen_loguniformUnc (DataVariablesRep *dv, size_t i0) |
static void | Vadj_Triangular (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vbgen_triangularUnc (DataVariablesRep *dv, size_t i0) |
static void | Vadj_Exponential (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vbgen_Exponential (DataVariablesRep *dv, size_t i0) |
static void | Vadj_Beta (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vbgen_betaUnc (DataVariablesRep *dv, size_t i0) |
static void | Vadj_Gamma (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vbgen_Gamma (DataVariablesRep *dv, size_t i0) |
static void | Vadj_Gumbel (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vbgen_Gumbel (DataVariablesRep *dv, size_t i0) |
static void | Vadj_Frechet (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vbgen_Frechet (DataVariablesRep *dv, size_t i0) |
static void | Vadj_Weibull (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vbgen_Weibull (DataVariablesRep *dv, size_t i0) |
static void | Vadj_HistogramBin (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vadj_Poisson (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vadj_Binomial (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vadj_NegBinomial (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vadj_Geometric (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vadj_HyperGeom (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vadj_HistogramPt (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vbgen_HistogramBin (DataVariablesRep *dv, size_t i0) |
static void | Vbgen_HistogramPt (DataVariablesRep *dv, size_t i0) |
static void | Vadj_Interval (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vbgen_Interval (DataVariablesRep *dv, size_t i0) |
static void | Vbgen_Poisson (DataVariablesRep *dv, size_t i0) |
static void | Vbgen_Binomial (DataVariablesRep *dv, size_t i0) |
static void | Vbgen_NegBinomial (DataVariablesRep *dv, size_t i0) |
static void | Vbgen_Geometric (DataVariablesRep *dv, size_t i0) |
static void | Vbgen_HyperGeom (DataVariablesRep *dv, size_t i0) |
static void | DIset (size_t n, IntSetArray *a, IntVector *L, IntVector *U, IntVector *V) |
static void | DRset (size_t n, RealSetArray *a, RealVector *L, RealVector *U, RealVector *V) |
static void | Vbgen_DDSI (DataVariablesRep *dv, size_t n) |
static void | Vbgen_DDSR (DataVariablesRep *dv, size_t n) |
static void | Vbgen_DSSI (DataVariablesRep *dv, size_t n) |
static void | Vbgen_DSSR (DataVariablesRep *dv, size_t n) |
static void | not_div (const char *kind, size_t nsv, size_t m) |
static void | wrong_number (const char *what, const char *kind, size_t nsv, size_t m) |
static void | too_small (const char *kind) |
static void | suppressed (const char *kind, int ndup, int *ip, Real *rp) |
static void | bad_initial_ivalue (const char *kind, int val) |
static void | bad_initial_rvalue (const char *kind, Real val) |
static void | Vadj_DiscreteDesSetReal (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vadj_DiscreteDesSetInt (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vadj_DiscreteStateSetReal (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Vadj_DiscreteStateSetInt (DataVariablesRep *dv, size_t i0, Var_Info *vi) |
static void | Rdv_copy (RealVector **prdv, RealVectorArray *rdva) |
static void | var_iulbl (const char *keyname, Values *val, VarLabel *vl) |
static Iface_mp_Rlit | MP3 (failAction, recoveryFnVals, recover) |
static Iface_mp_ilit | MP3 (failAction, retryLimit, retry) |
static Iface_mp_lit | MP2 (analysisScheduling, self) |
static Iface_mp_lit | MP2 (analysisScheduling, static) |
static Iface_mp_lit | MP2 (evalScheduling, self) |
static Iface_mp_lit | MP2 (evalScheduling, static) |
static Iface_mp_lit | MP2 (failAction, abort) |
static Iface_mp_lit | MP2 (failAction, continuation) |
static Iface_mp_lit | MP2 (interfaceSynchronization, asynchronous) |
static Iface_mp_lit | MP2 (interfaceType, direct) |
static Iface_mp_lit | MP2 (interfaceType, fork) |
static Iface_mp_lit | MP2 (interfaceType, grid) |
static Iface_mp_lit | MP2 (interfaceType, system) |
static Iface_mp_lit | MP2 (asynchLocalEvalScheduling, self) |
static Iface_mp_lit | MP2 (asynchLocalEvalScheduling, static) |
static String | MP_ (idInterface) |
static String | MP_ (inputFilter) |
static String | MP_ (outputFilter) |
static String | MP_ (parametersFile) |
static String | MP_ (resultsFile) |
static String | MP_ (templateDir) |
static String | MP_ (workDir) |
static String2DArray | MP_ (analysisComponents) |
static StringArray | MP_ (analysisDrivers) |
static StringArray | MP_ (templateFiles) |
static bool | MP_ (activeSetVectorFlag) |
static bool | MP_ (allowExistingResultsFlag) |
static bool | MP_ (apreproFlag) |
static bool | MP_ (dirSave) |
static bool | MP_ (dirTag) |
static bool | MP_ (evalCacheFlag) |
static bool | MP_ (fileSaveFlag) |
static bool | MP_ (fileTagFlag) |
static bool | MP_ (restartFileFlag) |
static bool | MP_ (templateCopy) |
static bool | MP_ (templateReplace) |
static bool | MP_ (useWorkdir) |
static bool | MP_ (verbatimFlag) |
static int | MP_ (analysisServers) |
static int | MP_ (asynchLocalAnalysisConcurrency) |
static int | MP_ (asynchLocalEvalConcurrency) |
static int | MP_ (evalServers) |
static int | MP_ (procsPerAnalysis) |
static IntVector | MP_ (primeBase) |
static IntVector | MP_ (sequenceLeap) |
static IntVector | MP_ (sequenceStart) |
static IntVector | MP_ (stepsPerVariable) |
static Method_mp_ilit2 | MP3 (replacementType, numberRetained, chc) |
static Method_mp_ilit2 | MP3 (replacementType, numberRetained, elitist) |
static Method_mp_ilit2 | MP3 (replacementType, numberRetained, random) |
static Method_mp_ilit2z | MP3 (crossoverType, numCrossPoints, multi_point_binary) |
static Method_mp_ilit2z | MP3 (crossoverType, numCrossPoints, multi_point_parameterized_binary) |
static Method_mp_ilit2z | MP3 (crossoverType, numCrossPoints, multi_point_real) |
static Method_mp_lit | MP2 (boxDivision, all_dimensions) |
static Method_mp_lit | MP2 (boxDivision, major_dimension) |
static Method_mp_lit | MP2 (collocPtReuse, all) |
static Method_mp_lit | MP2 (convergenceType, average_fitness_tracker) |
static Method_mp_lit | MP2 (convergenceType, best_fitness_tracker) |
static Method_mp_lit | MP2 (convergenceType, metric_tracker) |
static Method_mp_lit | MP2 (crossoverType, blend) |
static Method_mp_lit | MP2 (crossoverType, two_point) |
static Method_mp_lit | MP2 (crossoverType, uniform) |
static Method_mp_lit | MP2 (distributionType, complementary) |
static Method_mp_lit | MP2 (distributionType, cumulative) |
static Method_mp_lit | MP2 (evalSynchronization, blocking) |
static Method_mp_lit | MP2 (evalSynchronization, nonblocking) |
static Method_mp_lit | MP2 (evalSynchronize, blocking) |
static Method_mp_lit | MP2 (evalSynchronize, nonblocking) |
static Method_mp_lit | MP2 (expansionSampleType, incremental_lhs) |
static Method_mp_lit | MP2 (exploratoryMoves, adaptive) |
static Method_mp_lit | MP2 (exploratoryMoves, multi_step) |
static Method_mp_lit | MP2 (exploratoryMoves, simple) |
static Method_mp_lit | MP2 (fitnessType, domination_count) |
static Method_mp_lit | MP2 (fitnessType, layer_rank) |
static Method_mp_lit | MP2 (fitnessType, linear_rank) |
static Method_mp_lit | MP2 (fitnessType, merit_function) |
static Method_mp_lit | MP2 (fitnessType, proportional) |
static Method_mp_lit | MP2 (initializationType, random) |
static Method_mp_lit | MP2 (initializationType, unique_random) |
static Method_mp_lit | MP2 (integrationRefine, ais) |
static Method_mp_lit | MP2 (integrationRefine, is) |
static Method_mp_lit | MP2 (integrationRefine, mmais) |
static Method_mp_lit | MP2 (meritFunction, merit_max) |
static Method_mp_lit | MP2 (meritFunction, merit_max_smooth) |
static Method_mp_lit | MP2 (meritFunction, merit1) |
static Method_mp_lit | MP2 (meritFunction, merit1_smooth) |
static Method_mp_lit | MP2 (meritFunction, merit2) |
static Method_mp_lit | MP2 (meritFunction, merit2_smooth) |
static Method_mp_lit | MP2 (meritFunction, merit2_squared) |
static Method_mp_lit | MP2 (methodName, asynch_pattern_search) |
static Method_mp_lit | MP2 (methodName, coliny_cobyla) |
static Method_mp_lit | MP2 (methodName, coliny_direct) |
static Method_mp_lit | MP2 (methodName, coliny_pattern_search) |
static Method_mp_lit | MP2 (methodName, coliny_solis_wets) |
static Method_mp_lit | MP2 (methodName, conmin_frcg) |
static Method_mp_lit | MP2 (methodName, conmin_mfd) |
static Method_mp_lit | MP2 (methodName, dace) |
static Method_mp_lit | MP2 (methodName, dot_bfgs) |
static Method_mp_lit | MP2 (methodName, dot_frcg) |
static Method_mp_lit | MP2 (methodName, dot_mmfd) |
static Method_mp_lit | MP2 (methodName, dot_slp) |
static Method_mp_lit | MP2 (methodName, dot_sqp) |
static Method_mp_lit | MP2 (methodName, efficient_global) |
static Method_mp_lit | MP2 (methodName, fsu_cvt) |
static Method_mp_lit | MP2 (methodName, fsu_halton) |
static Method_mp_lit | MP2 (methodName, fsu_hammersley) |
static Method_mp_lit | MP2 (methodName, ncsu_direct) |
static Method_mp_lit | MP2 (methodName, nl2sol) |
static Method_mp_lit | MP2 (methodName, nlpql_sqp) |
static Method_mp_lit | MP2 (methodName, nlssol_sqp) |
static Method_mp_lit | MP2 (methodName, nond_bayes_calibration) |
static Method_mp_lit | MP2 (methodName, nond_global_evidence) |
static Method_mp_lit | MP2 (methodName, nond_global_interval_est) |
static Method_mp_lit | MP2 (methodName, nond_global_reliability) |
static Method_mp_lit | MP2 (methodName, nond_importance_sampling) |
static Method_mp_lit | MP2 (methodName, nond_local_evidence) |
static Method_mp_lit | MP2 (methodName, nond_local_interval_est) |
static Method_mp_lit | MP2 (methodName, nond_polynomial_chaos) |
static Method_mp_lit | MP2 (methodName, nond_sampling) |
static Method_mp_lit | MP2 (methodName, nond_stoch_collocation) |
static Method_mp_lit | MP2 (methodName, nonlinear_cg) |
static Method_mp_lit | MP2 (methodName, npsol_sqp) |
static Method_mp_lit | MP2 (methodName, optpp_cg) |
static Method_mp_lit | MP2 (methodName, optpp_fd_newton) |
static Method_mp_lit | MP2 (methodName, optpp_g_newton) |
static Method_mp_lit | MP2 (methodName, optpp_newton) |
static Method_mp_lit | MP2 (methodName, optpp_pds) |
static Method_mp_lit | MP2 (methodName, optpp_q_newton) |
static Method_mp_lit | MP2 (methodName, psuade_moat) |
static Method_mp_lit | MP2 (methodName, richardson_extrap) |
static Method_mp_lit | MP2 (methodName, surrogate_based_global) |
static Method_mp_lit | MP2 (methodName, surrogate_based_local) |
static Method_mp_lit | MP2 (methodName, vector_parameter_study) |
static Method_mp_lit | MP2 (methodName, list_parameter_study) |
static Method_mp_lit | MP2 (methodName, centered_parameter_study) |
static Method_mp_lit | MP2 (methodName, multidim_parameter_study) |
static Method_mp_lit | MP2 (minMaxType, maximize) |
static Method_mp_lit | MP2 (minMaxType, minimize) |
static Method_mp_lit | MP2 (mutationType, bit_random) |
static Method_mp_lit | MP2 (mutationType, offset_cauchy) |
static Method_mp_lit | MP2 (mutationType, offset_normal) |
static Method_mp_lit | MP2 (mutationType, offset_uniform) |
static Method_mp_lit | MP2 (mutationType, replace_uniform) |
static Method_mp_lit | MP2 (nondOptAlgorithm, nip) |
static Method_mp_lit | MP2 (nondOptAlgorithm, sqp) |
static Method_mp_lit | MP2 (nondOptAlgorithm, lhs) |
static Method_mp_lit | MP2 (nondOptAlgorithm, ego) |
static Method_mp_lit | MP2 (patternBasis, coordinate) |
static Method_mp_lit | MP2 (patternBasis, simplex) |
static Method_mp_lit | MP2 (reliabilityIntegration, first_order) |
static Method_mp_lit | MP2 (reliabilityIntegration, second_order) |
static Method_mp_lit | MP2 (reliabilitySearchType, amv_plus_u) |
static Method_mp_lit | MP2 (reliabilitySearchType, amv_plus_x) |
static Method_mp_lit | MP2 (reliabilitySearchType, amv_u) |
static Method_mp_lit | MP2 (reliabilitySearchType, amv_x) |
static Method_mp_lit | MP2 (reliabilitySearchType, egra_u) |
static Method_mp_lit | MP2 (reliabilitySearchType, egra_x) |
static Method_mp_lit | MP2 (reliabilitySearchType, no_approx) |
static Method_mp_lit | MP2 (reliabilitySearchType, tana_u) |
static Method_mp_lit | MP2 (reliabilitySearchType, tana_x) |
static Method_mp_lit | MP2 (replacementType, elitist) |
static Method_mp_lit | MP2 (replacementType, favor_feasible) |
static Method_mp_lit | MP2 (replacementType, roulette_wheel) |
static Method_mp_lit | MP2 (replacementType, unique_roulette_wheel) |
static Method_mp_lit | MP2 (responseLevelMappingType, gen_reliabilities) |
static Method_mp_lit | MP2 (responseLevelMappingType, probabilities) |
static Method_mp_lit | MP2 (responseLevelMappingType, reliabilities) |
static Method_mp_lit | MP2 (rngName, mt19937) |
static Method_mp_lit | MP2 (rngName, rnum2) |
static Method_mp_lit | MP2 (sampleType, incremental_lhs) |
static Method_mp_lit | MP2 (sampleType, incremental_random) |
static Method_mp_lit | MP2 (sampleType, lhs) |
static Method_mp_lit | MP2 (sampleType, random) |
static Method_mp_lit | MP2 (searchMethod, gradient_based_line_search) |
static Method_mp_lit | MP2 (searchMethod, tr_pds) |
static Method_mp_lit | MP2 (searchMethod, trust_region) |
static Method_mp_lit | MP2 (searchMethod, value_based_line_search) |
static Method_mp_lit | MP2 (subMethodName, box_behnken) |
static Method_mp_lit | MP2 (subMethodName, central_composite) |
static Method_mp_lit | MP2 (subMethodName, gpmsa) |
static Method_mp_lit | MP2 (subMethodName, grid) |
static Method_mp_lit | MP2 (subMethodName, lhs) |
static Method_mp_lit | MP2 (subMethodName, oa_lhs) |
static Method_mp_lit | MP2 (subMethodName, oas) |
static Method_mp_lit | MP2 (subMethodName, queso) |
static Method_mp_lit | MP2 (subMethodName, random) |
static Method_mp_lit | MP2 (subMethodName, converge_order) |
static Method_mp_lit | MP2 (subMethodName, converge_qoi) |
static Method_mp_lit | MP2 (subMethodName, estimate_order) |
static Method_mp_lit | MP2 (trialType, grid) |
static Method_mp_lit | MP2 (trialType, halton) |
static Method_mp_lit | MP2 (trialType, random) |
static Method_mp_lit2 | MP4 (methodName, reliabilitySearchType, nond_local_reliability,"mv") |
static Method_mp_litc | MP3 (crossoverType, crossoverRate, shuffle_random) |
static Method_mp_litc | MP3 (crossoverType, crossoverRate, null_crossover) |
static Method_mp_litc | MP3 (mutationType, mutationRate, null_mutation) |
static Method_mp_litc | MP3 (mutationType, mutationRate, offset_cauchy) |
static Method_mp_litc | MP3 (mutationType, mutationRate, offset_normal) |
static Method_mp_litc | MP3 (mutationType, mutationRate, offset_uniform) |
static Method_mp_litc | MP3 (replacementType, fitnessLimit, below_limit) |
static Method_mp_litrv | MP3 (nichingType, nicheVector, distance) |
static Method_mp_litrv | MP3 (nichingType, nicheVector, radial) |
static Method_mp_litrv | MP3 (postProcessorType, distanceVector, distance_postprocessor) |
static Method_mp_slit | MP2a (methodOutput, DEBUG_OUTPUT) |
static Method_mp_slit | MP2a (methodOutput, QUIET_OUTPUT) |
static Method_mp_slit | MP2a (methodOutput, SILENT_OUTPUT) |
static Method_mp_slit | MP2a (methodOutput, VERBOSE_OUTPUT) |
static Method_mp_slit | MP2a (surrBasedLocalAcceptLogic, FILTER) |
static Method_mp_slit | MP2a (surrBasedLocalAcceptLogic, TR_RATIO) |
static Method_mp_slit | MP2a (surrBasedLocalConstrRelax, HOMOTOPY) |
static Method_mp_slit | MP2a (surrBasedLocalMeritFn, ADAPTIVE_PENALTY_MERIT) |
static Method_mp_slit | MP2a (surrBasedLocalMeritFn, AUGMENTED_LAGRANGIAN_MERIT) |
static Method_mp_slit | MP2a (surrBasedLocalMeritFn, LAGRANGIAN_MERIT) |
static Method_mp_slit | MP2a (surrBasedLocalMeritFn, PENALTY_MERIT) |
static Method_mp_slit | MP2a (surrBasedLocalSubProbCon, LINEARIZED_CONSTRAINTS) |
static Method_mp_slit | MP2a (surrBasedLocalSubProbCon, NO_CONSTRAINTS) |
static Method_mp_slit | MP2a (surrBasedLocalSubProbCon, ORIGINAL_CONSTRAINTS) |
static Method_mp_slit | MP2a (surrBasedLocalSubProbObj, AUGMENTED_LAGRANGIAN_OBJECTIVE) |
static Method_mp_slit | MP2a (surrBasedLocalSubProbObj, LAGRANGIAN_OBJECTIVE) |
static Method_mp_slit | MP2a (surrBasedLocalSubProbObj, ORIGINAL_PRIMARY) |
static Method_mp_slit | MP2a (surrBasedLocalSubProbObj, SINGLE_OBJECTIVE) |
static Method_mp_slit2 | MP3 (initializationType, flatFile, flat_file) |
static Method_mp_slit2 | MP3 (methodName, dlDetails, dl_solver) |
static Real | MP_ (absConvTol) |
static Real | MP_ (centeringParam) |
static Real | MP_ (collocationRatio) |
static Real | MP_ (constraintPenalty) |
static Real | MP_ (constrPenalty) |
static Real | MP_ (constraintTolerance) |
static Real | MP_ (contractFactor) |
static Real | MP_ (contractStepLength) |
static Real | MP_ (convergenceTolerance) |
static Real | MP_ (crossoverRate) |
static Real | MP_ (falseConvTol) |
static Real | MP_ (functionPrecision) |
static Real | MP_ (globalBalanceParam) |
static Real | MP_ (gradientTolerance) |
static Real | MP_ (initDelta) |
static Real | MP_ (initStepLength) |
static Real | MP_ (initTRRadius) |
static Real | MP_ (lineSearchTolerance) |
static Real | MP_ (localBalanceParam) |
static Real | MP_ (maxBoxSize) |
static Real | MP_ (maxStep) |
static Real | MP_ (minBoxSize) |
static Real | MP_ (mutationRate) |
static Real | MP_ (mutationScale) |
static Real | MP_ (refinementRate) |
static Real | MP_ (shrinkagePercent) |
static Real | MP_ (singConvTol) |
static Real | MP_ (singRadius) |
static Real | MP_ (smoothFactor) |
static Real | MP_ (solnTarget) |
static Real | MP_ (stepLenToBoundary) |
static Real | MP_ (surrBasedLocalTRContract) |
static Real | MP_ (surrBasedLocalTRContractTrigger) |
static Real | MP_ (surrBasedLocalTRExpand) |
static Real | MP_ (surrBasedLocalTRExpandTrigger) |
static Real | MP_ (surrBasedLocalTRInitSize) |
static Real | MP_ (surrBasedLocalTRMinSize) |
static Real | MP_ (threshDelta) |
static Real | MP_ (threshStepLength) |
static Real | MP_ (vbdDropTolerance) |
static Real | MP_ (volBoxSize) |
static Real | MP_ (xConvTol) |
static RealVector | MP_ (finalPoint) |
static RealVector | MP_ (linearEqConstraintCoeffs) |
static RealVector | MP_ (linearEqTargets) |
static RealVector | MP_ (linearEqScales) |
static RealVector | MP_ (linearIneqConstraintCoeffs) |
static RealVector | MP_ (linearIneqLowerBnds) |
static RealVector | MP_ (linearIneqUpperBnds) |
static RealVector | MP_ (linearIneqScales) |
static RealVector | MP_ (listOfPoints) |
static RealVector | MP_ (sparseGridDimPref) |
static RealVector | MP_ (stepVector) |
static RealVectorArray | MP_ (genReliabilityLevels) |
static RealVectorArray | MP_ (probabilityLevels) |
static RealVectorArray | MP_ (reliabilityLevels) |
static RealVectorArray | MP_ (responseLevels) |
static unsigned short | MP_ (cubIntOrder) |
static unsigned short | MP_ (sparseGridLevel) |
static UShortArray | MP_ (expansionOrder) |
static UShortArray | MP_ (quadratureOrder) |
static UShortArray | MP_ (varPartitions) |
static String | MP_ (centralPath) |
static String | MP_ (expansionImportFile) |
static String | MP_ (idMethod) |
static String | MP_ (logFile) |
static String | MP_ (meritFn) |
static String | MP_ (modelPointer) |
static String | MP_ (subMethodName) |
static String | MP_ (subMethodPointer) |
static String | MP_ (xObsDataFile) |
static String | MP_ (yObsDataFile) |
static String | MP_ (yStdDataFile) |
static StringArray | MP_ (linearEqScaleTypes) |
static StringArray | MP_ (linearIneqScaleTypes) |
static StringArray | MP_ (miscOptions) |
static bool | MP_ (allVarsFlag) |
static bool | MP_ (constantPenalty) |
static bool | MP_ (expansionDerivUsageFlag) |
static bool | MP_ (expansionFlag) |
static bool | MP_ (fixedSeedFlag) |
static bool | MP_ (fixedSequenceFlag) |
static bool | MP_ (latinizeFlag) |
static bool | MP_ (mainEffectsFlag) |
static bool | MP_ (methodScaling) |
static bool | MP_ (mutationAdaptive) |
static bool | MP_ (printPopFlag) |
static bool | MP_ (randomizeOrderFlag) |
static bool | MP_ (regressDiag) |
static bool | MP_ (showMiscOptions) |
static bool | MP_ (speculativeFlag) |
static bool | MP_ (surrBasedGlobalReplacePts) |
static bool | MP_ (surrBasedLocalLayerBypass) |
static bool | MP_ (vbdFlag) |
static bool | MP_ (volQualityFlag) |
static short | MP_ (expansionType) |
static short | MP_ (nestingOverride) |
static short | MP_ (refinementType) |
static int | MP_ (collocationPoints) |
static int | MP_ (contractAfterFail) |
static int | MP_ (covarianceType) |
static int | MP_ (expandAfterSuccess) |
static int | MP_ (expansionSamples) |
static int | MP_ (expansionTerms) |
static int | MP_ (maxFunctionEvaluations) |
static int | MP_ (maxIterations) |
static int | MP_ (mutationRange) |
static int | MP_ (newSolnsGenerated) |
static int | MP_ (numSamples) |
static int | MP_ (numSteps) |
static int | MP_ (numSymbols) |
static int | MP_ (numTrials) |
static int | MP_ (populationSize) |
static int | MP_ (previousSamples) |
static int | MP_ (randomSeed) |
static int | MP_ (searchSchemeSize) |
static int | MP_ (surrBasedLocalSoftConvLimit) |
static int | MP_ (totalPatternSize) |
static int | MP_ (verifyLevel) |
static size_t | MP_ (numFinalSolutions) |
static size_t | MP_ (numGenerations) |
static size_t | MP_ (numOffspring) |
static size_t | MP_ (numParents) |
static Method_mp_type | MP2s (expansionType, ASKEY_U) |
static Method_mp_type | MP2s (expansionType, STD_NORMAL_U) |
static Method_mp_type | MP2p (nestingOverride, NESTED) |
static Method_mp_type | MP2p (nestingOverride, NON_NESTED) |
static Method_mp_type | MP2p (refinementControl, GENERALIZED_SPARSE) |
static Method_mp_type | MP2p (refinementControl, SPECTRAL_DECAY) |
static Method_mp_type | MP2p (refinementControl, TOTAL_SOBOL) |
static Method_mp_type | MP2p (refinementType, ADAPTIVE_P_REFINEMENT) |
static Method_mp_type | MP2p (refinementType, UNIFORM_P_REFINEMENT) |
static Method_mp_type | MP2p (vbdControl, UNIVARIATE_VBD) |
static IntSet | MP_ (surrogateFnIndices) |
static Model_mp_lit | MP2 (approxCorrectionType, additive) |
static Model_mp_lit | MP2 (approxCorrectionType, combined) |
static Model_mp_lit | MP2 (approxCorrectionType, multiplicative) |
static Model_mp_lit | MP2 (approxPointReuse, all) |
static Model_mp_lit | MP2 (approxPointReuse, none) |
static Model_mp_lit | MP2 (approxPointReuse, region) |
static Model_mp_lit | MP2 (marsInterpolation, linear) |
static Model_mp_lit | MP2 (marsInterpolation, cubic) |
static Model_mp_lit | MP2 (modelType, nested) |
static Model_mp_lit | MP2 (modelType, single) |
static Model_mp_lit | MP2 (modelType, surrogate) |
static Model_mp_lit | MP2 (surrogateType, hierarchical) |
static Model_mp_lit | MP2 (surrogateType, global_gaussian) |
static Model_mp_lit | MP2 (surrogateType, global_kriging) |
static Model_mp_lit | MP2 (surrogateType, global_mars) |
static Model_mp_lit | MP2 (surrogateType, global_moving_least_squares) |
static Model_mp_lit | MP2 (surrogateType, global_neural_network) |
static Model_mp_lit | MP2 (surrogateType, global_polynomial) |
static Model_mp_lit | MP2 (surrogateType, global_radial_basis) |
static Model_mp_lit | MP2 (surrogateType, local_taylor) |
static Model_mp_lit | MP2 (surrogateType, multipoint_tana) |
static Model_mp_lit | MP2 (trendOrder, constant) |
static Model_mp_lit | MP2 (trendOrder, linear) |
static Model_mp_lit | MP2 (trendOrder, reduced_quadratic) |
static Model_mp_lit | MP2 (trendOrder, quadratic) |
static Model_mp_ord | MP2s (approxCorrectionOrder, 0) |
static Model_mp_ord | MP2s (approxCorrectionOrder, 1) |
static Model_mp_ord | MP2s (approxCorrectionOrder, 2) |
static Model_mp_ord | MP2s (polynomialOrder, 1) |
static Model_mp_ord | MP2s (polynomialOrder, 2) |
static Model_mp_ord | MP2s (polynomialOrder, 3) |
static Real | MP_ (annRange) |
static RealVector | MP_ (krigingCorrelations) |
static RealVector | MP_ (primaryRespCoeffs) |
static RealVector | MP_ (secondaryRespCoeffs) |
static String | MP_ (approxPointReuseFile) |
static String | MP_ (idModel) |
static String | MP_ (interfacePointer) |
static String | MP_ (krigingOptMethod) |
static String | MP_ (lowFidelityModelPointer) |
static String | MP_ (optionalInterfRespPointer) |
static String | MP_ (responsesPointer) |
static String | MP_ (truthModelPointer) |
static String | MP_ (variablesPointer) |
static StringArray | MP_ (primaryVarMaps) |
static StringArray | MP_ (secondaryVarMaps) |
static StringArray | MP_ (diagMetrics) |
static bool | MP_ (approxDerivUsageFlag) |
static bool | MP_ (pointsMinimum) |
static bool | MP_ (pointsRecommended) |
static bool | MP_ (pointSelection) |
static short | MP_ (annNodes) |
static short | MP_ (annRandomWeight) |
static short | MP_ (krigingMaxTrials) |
static short | MP_ (marsMaxBases) |
static short | MP_ (mlsPolyOrder) |
static short | MP_ (mlsWeightFunction) |
static short | MP_ (rbfBases) |
static short | MP_ (rbfMaxPts) |
static short | MP_ (rbfMaxSubsets) |
static short | MP_ (rbfMinPartition) |
static int | MP_ (pointsTotal) |
static IntList | MP_ (idAnalyticGrads) |
static IntList | MP_ (idAnalyticHessians) |
static IntList | MP_ (idNumericalGrads) |
static IntList | MP_ (idNumericalHessians) |
static IntList | MP_ (idQuasiHessians) |
static RealVector | MP_ (primaryRespFnWeights) |
static RealVector | MP_ (nonlinearEqTargets) |
static RealVector | MP_ (nonlinearIneqLowerBnds) |
static RealVector | MP_ (nonlinearIneqUpperBnds) |
static RealVector | MP_ (fdGradStepSize) |
static RealVector | MP_ (fdHessStepSize) |
static RealVector | MP_ (primaryRespFnScales) |
static RealVector | MP_ (nonlinearEqScales) |
static RealVector | MP_ (nonlinearIneqScales) |
static Resp_mp_lit | MP2 (gradientType, analytic) |
static Resp_mp_lit | MP2 (gradientType, mixed) |
static Resp_mp_lit | MP2 (gradientType, none) |
static Resp_mp_lit | MP2 (gradientType, numerical) |
static Resp_mp_lit | MP2 (hessianType, analytic) |
static Resp_mp_lit | MP2 (hessianType, mixed) |
static Resp_mp_lit | MP2 (hessianType, none) |
static Resp_mp_lit | MP2 (hessianType, numerical) |
static Resp_mp_lit | MP2 (hessianType, quasi) |
static Resp_mp_lit | MP2 (intervalType, central) |
static Resp_mp_lit | MP2 (intervalType, forward) |
static Resp_mp_lit | MP2 (methodSource, dakota) |
static Resp_mp_lit | MP2 (methodSource, vendor) |
static Resp_mp_lit | MP2 (quasiHessianType, bfgs) |
static Resp_mp_lit | MP2 (quasiHessianType, damped_bfgs) |
static Resp_mp_lit | MP2 (quasiHessianType, sr1) |
static String | MP_ (idResponses) |
static String | MP_ (leastSqDataFile) |
static StringArray | MP_ (primaryRespFnScaleTypes) |
static StringArray | MP_ (nonlinearEqScaleTypes) |
static StringArray | MP_ (nonlinearIneqScaleTypes) |
static StringArray | MP_ (responseLabels) |
static bool | MP_ (centralHess) |
static bool | MP_ (ignoreBounds) |
static size_t | MP_ (numLeastSqTerms) |
static size_t | MP_ (numNonlinearEqConstraints) |
static size_t | MP_ (numNonlinearIneqConstraints) |
static size_t | MP_ (numObjectiveFunctions) |
static size_t | MP_ (numResponseFunctions) |
static Real | MP_ (hybridLSProb) |
static RealVector | MP_ (concurrentParameterSets) |
static Strategy_mp_lit | MP2 (hybridType, collaborative) |
static Strategy_mp_lit | MP2 (hybridType, embedded) |
static Strategy_mp_lit | MP2 (hybridType, sequential) |
static Strategy_mp_lit | MP2 (iteratorScheduling, self) |
static Strategy_mp_lit | MP2 (iteratorScheduling, static) |
static Strategy_mp_lit | MP2 (strategyType, hybrid) |
static Strategy_mp_lit | MP2 (strategyType, multi_start) |
static Strategy_mp_lit | MP2 (strategyType, pareto_set) |
static Strategy_mp_lit | MP2 (strategyType, single_method) |
static String | MP_ (hybridGlobalMethodPointer) |
static String | MP_ (hybridLocalMethodPointer) |
static String | MP_ (methodPointer) |
static String | MP_ (tabularDataFile) |
static StringArray | MP_ (hybridMethodList) |
static bool | MP_ (graphicsFlag) |
static bool | MP_ (tabularDataFlag) |
static int | MP_ (concurrentRandomJobs) |
static int | MP_ (concurrentSeed) |
static int | MP_ (iteratorServers) |
static int | MP_ (outputPrecision) |
static size_t | MP_ (numBetaUncVars) |
static size_t | MP_ (numBinomialUncVars) |
static size_t | MP_ (numContinuousDesVars) |
static size_t | MP_ (numContinuousStateVars) |
static size_t | MP_ (numDiscreteDesRangeVars) |
static size_t | MP_ (numDiscreteDesSetIntVars) |
static size_t | MP_ (numDiscreteDesSetRealVars) |
static size_t | MP_ (numDiscreteStateRangeVars) |
static size_t | MP_ (numDiscreteStateSetIntVars) |
static size_t | MP_ (numDiscreteStateSetRealVars) |
static size_t | MP_ (numExponentialUncVars) |
static size_t | MP_ (numFrechetUncVars) |
static size_t | MP_ (numGammaUncVars) |
static size_t | MP_ (numGeometricUncVars) |
static size_t | MP_ (numGumbelUncVars) |
static size_t | MP_ (numHistogramBinUncVars) |
static size_t | MP_ (numHistogramPtUncVars) |
static size_t | MP_ (numHyperGeomUncVars) |
static size_t | MP_ (numIntervalUncVars) |
static size_t | MP_ (numLognormalUncVars) |
static size_t | MP_ (numLoguniformUncVars) |
static size_t | MP_ (numNegBinomialUncVars) |
static size_t | MP_ (numNormalUncVars) |
static size_t | MP_ (numPoissonUncVars) |
static size_t | MP_ (numTriangularUncVars) |
static size_t | MP_ (numUniformUncVars) |
static size_t | MP_ (numWeibullUncVars) |
static IntVector | MP_ (binomialUncNumTrials) |
static IntVector | MP_ (hyperGeomUncTotalPop) |
static IntVector | MP_ (hyperGeomUncSelectedPop) |
static IntVector | MP_ (hyperGeomUncNumDrawn) |
static IntVector | MP_ (negBinomialUncNumTrials) |
static IntVector | MP_ (discreteDesignRangeLowerBnds) |
static IntVector | MP_ (discreteDesignRangeUpperBnds) |
static IntVector | MP_ (discreteDesignRangeVars) |
static IntVector | MP_ (discreteDesignSetIntVars) |
static IntVector | MP_ (discreteStateRangeLowerBnds) |
static IntVector | MP_ (discreteStateRangeUpperBnds) |
static IntVector | MP_ (discreteStateRangeVars) |
static IntVector | MP_ (discreteStateSetIntVars) |
static IntArray | VP_ (dsvi) |
static IntArray | VP_ (ndsvi) |
static IntArray | VP_ (ndsvr) |
static IntArray | VP_ (nIv) |
static IntArray | VP_ (nbp) |
static IntArray | VP_ (npp) |
static IntArray | VP_ (nssvi) |
static IntArray | VP_ (nssvr) |
static IntArray | VP_ (ssvi) |
static RealVector | MP_ (betaUncLowerBnds) |
static RealVector | MP_ (betaUncUpperBnds) |
static RealVector | MP_ (binomialUncProbPerTrial) |
static RealVector | MP_ (continuousDesignLowerBnds) |
static RealVector | MP_ (continuousDesignUpperBnds) |
static RealVector | MP_ (continuousDesignVars) |
static RealVector | MP_ (continuousDesignScales) |
static RealVector | MP_ (continuousStateLowerBnds) |
static RealVector | MP_ (continuousStateUpperBnds) |
static RealVector | MP_ (continuousStateVars) |
static RealVector | MP_ (discreteDesignSetRealVars) |
static RealVector | MP_ (discreteStateSetRealVars) |
static RealVector | MP_ (frechetUncBetas) |
static RealVector | MP_ (geometricUncProbPerTrial) |
static RealVector | MP_ (gumbelUncBetas) |
static RealVector | MP_ (negBinomialUncProbPerTrial) |
static RealVector | MP_ (normalUncLowerBnds) |
static RealVector | MP_ (normalUncMeans) |
static RealVector | MP_ (normalUncUpperBnds) |
static RealVector | MP_ (poissonUncLambdas) |
static RealVector | MP_ (triangularUncModes) |
static RealVector | VP_ (dsvr) |
static RealVector | VP_ (Ivb) |
static RealVector | VP_ (Ivp) |
static RealVector | VP_ (ba) |
static RealVector | VP_ (bo) |
static RealVector | VP_ (bc) |
static RealVector | VP_ (pa) |
static RealVector | VP_ (pc) |
static RealVector | VP_ (ucm) |
static RealVector | VP_ (ssvr) |
static String | MP_ (idVariables) |
static StringArray | MP_ (continuousDesignLabels) |
static StringArray | MP_ (continuousDesignScaleTypes) |
static StringArray | MP_ (continuousStateLabels) |
static StringArray | MP_ (discreteDesignRangeLabels) |
static StringArray | MP_ (discreteDesignSetIntLabels) |
static StringArray | MP_ (discreteDesignSetRealLabels) |
static StringArray | MP_ (discreteStateRangeLabels) |
static StringArray | MP_ (discreteStateSetIntLabels) |
static StringArray | MP_ (discreteStateSetRealLabels) |
static Var_brv | MP2s (betaUncAlphas, 0.) |
static Var_brv | MP2s (betaUncBetas, 0.) |
static Var_brv | MP2s (exponentialUncBetas, 0.) |
static Var_brv | MP2s (frechetUncAlphas, 2.) |
static Var_brv | MP2s (gammaUncAlphas, 0.) |
static Var_brv | MP2s (gammaUncBetas, 0.) |
static Var_brv | MP2s (gumbelUncAlphas, 0.) |
static Var_brv | MP2s (lognormalUncErrFacts, 1.) |
static Var_brv | MP2s (lognormalUncLambdas, 0.) |
static Var_brv | MP2s (lognormalUncLowerBnds, 0.) |
static Var_brv | MP2s (lognormalUncMeans, 0.) |
static Var_brv | MP2s (lognormalUncStdDevs, 0.) |
static Var_brv | MP2s (lognormalUncUpperBnds, DBL_MAX) |
static Var_brv | MP2s (lognormalUncZetas, 0.) |
static Var_brv | MP2s (loguniformUncLowerBnds, 0.) |
static Var_brv | MP2s (loguniformUncUpperBnds, DBL_MAX) |
static Var_brv | MP2s (normalUncStdDevs, 0.) |
static Var_brv | MP2s (triangularUncLowerBnds,-DBL_MAX) |
static Var_brv | MP2s (triangularUncUpperBnds, DBL_MAX) |
static Var_brv | MP2s (uniformUncLowerBnds,-DBL_MAX) |
static Var_brv | MP2s (uniformUncUpperBnds, DBL_MAX) |
static Var_brv | MP2s (weibullUncAlphas, 0.) |
static Var_brv | MP2s (weibullUncBetas, 0.) |
static const char * | Var_Name (StringArray *sa, char *buf, size_t i) |
void | dn2f_ (int *n, int *p, Real *x, Calcrj, int *iv, int *liv, int *lv, Real *v, int *ui, void *ur, Vf) |
void | dn2fb_ (int *n, int *p, Real *x, Real *b, Calcrj, int *iv, int *liv, int *lv, Real *v, int *ui, void *ur, Vf) |
void | dn2g_ (int *n, int *p, Real *x, Calcrj, Calcrj, int *iv, int *liv, int *lv, Real *v, int *ui, void *ur, Vf) |
void | dn2gb_ (int *n, int *p, Real *x, Real *b, Calcrj, Calcrj, int *iv, int *liv, int *lv, Real *v, int *ui, void *ur, Vf) |
void | divset_ (int *, int *, int *, int *, Real *) |
double | dr7mdc_ (int *) |
static void | Rswapchk (Nl2Misc *q) |
static int | hasnaninf (const double *d, int n) |
Real | rel_change_c_star (const RealVector &curr_c_star, const RealVector &prev_c_star) |
Computes relative change between successive c_stars using Euclidean norm. | |
std::istream & | operator>> (std::istream &s, ParamResponsePair &pair) |
std::istream extraction operator for ParamResponsePair | |
std::ostream & | operator<< (std::ostream &s, const ParamResponsePair &pair) |
std::ostream insertion operator for ParamResponsePair | |
BiStream & | operator>> (BiStream &s, ParamResponsePair &pair) |
BiStream extraction operator for ParamResponsePair. | |
BoStream & | operator<< (BoStream &s, const ParamResponsePair &pair) |
BoStream insertion operator for ParamResponsePair. | |
MPIUnpackBuffer & | operator>> (MPIUnpackBuffer &s, ParamResponsePair &pair) |
MPIUnpackBuffer extraction operator for ParamResponsePair. | |
MPIPackBuffer & | operator<< (MPIPackBuffer &s, const ParamResponsePair &pair) |
MPIPackBuffer insertion operator for ParamResponsePair. | |
bool | operator== (const ParamResponsePair &pair1, const ParamResponsePair &pair2) |
equality operator for ParamResponsePair | |
bool | operator!= (const ParamResponsePair &pair1, const ParamResponsePair &pair2) |
inequality operator for ParamResponsePair | |
static void * | binsearch (void *kw, size_t kwsize, size_t n, const char *key) |
static const char * | Begins (const String &entry_name, const char *s) |
static void | Bad_name (String entry_name, const char *where) |
static void | Locked_db () |
static void | Null_rep (const char *who) |
static void | Null_rep1 (const char *who) |
bool | set_compare (const ParamResponsePair &database_pr, const ActiveSet &search_set) |
search function for a particular ParamResponsePair within a PRPList based on ActiveSet content (request vector and derivative variables vector) | |
bool | id_vars_exact_compare (const ParamResponsePair &database_pr, const ParamResponsePair &search_pr) |
search function for a particular ParamResponsePair within a PRPMultiIndex | |
std::size_t | hash_value (const ParamResponsePair &prp) |
hash_value for ParamResponsePairs stored in a PRPMultiIndex | |
PRPCacheHIter | hashedCacheBegin (PRPCache &prp_cache) |
hashed definition of cache begin | |
PRPCacheHIter | hashedCacheEnd (PRPCache &prp_cache) |
hashed definition of cache end | |
PRPQueueHIter | hashedQueueBegin (PRPQueue &prp_queue) |
hashed definition of queue begin | |
PRPQueueHIter | hashedQueueEnd (PRPQueue &prp_queue) |
hashed definition of queue end | |
PRPCacheHIter | lookup_by_val (PRPMultiIndexCache &prp_cache, const ParamResponsePair &search_pr) |
find a ParamResponsePair based on the interface id, variables, and ActiveSet search data within search_pr. | |
bool | lookup_by_val (PRPMultiIndexCache &prp_cache, const ParamResponsePair &search_pr, ParamResponsePair &found_pr) |
alternate overloaded form returns bool and sets found_pr by wrapping lookup_by_val(PRPMultiIndexCache&, ParamResponsePair&) | |
PRPCacheHIter | lookup_by_val (PRPMultiIndexCache &prp_cache, const String &search_interface_id, const Variables &search_vars, const ActiveSet &search_set) |
find the evaluation id of a ParamResponsePair within a PRPMultiIndexCache based on interface id, variables, and ActiveSet search data | |
bool | lookup_by_val (PRPMultiIndexCache &prp_cache, const String &search_interface_id, const Variables &search_vars, const ActiveSet &search_set, ParamResponsePair &found_pr) |
find a ParamResponsePair within a PRPMultiIndexCache based on interface id, variables, and ActiveSet search data | |
bool | lookup_by_val (PRPMultiIndexCache &prp_cache, const String &search_interface_id, const Variables &search_vars, const ActiveSet &search_set, int &found_eval_id) |
find the evaluation id of a ParamResponsePair within a PRPMultiIndexCache based on interface id, variables, and ActiveSet search data | |
bool | lookup_by_val (PRPMultiIndexCache &prp_cache, const String &search_interface_id, const Variables &search_vars, const ActiveSet &search_set, Response &found_resp) |
find the response of a ParamResponsePair within a PRPMultiIndexCache based on interface id, variables, and ActiveSet search data | |
PRPCacheOIter | lookup_by_ids (PRPMultiIndexCache &prp_cache, const IntStringPair &search_ids) |
find a ParamResponsePair within a PRPMultiIndexCache based on search_ids (i.e. std::pair<eval_id,interface_id>) search data | |
bool | lookup_by_ids (PRPMultiIndexCache &prp_cache, const IntStringPair &search_eval_interface_ids, ParamResponsePair &found_pr) |
find a ParamResponsePair within a PRPMultiIndexCache based on eval_interface_ids | |
bool | lookup_by_ids (PRPMultiIndexCache &prp_cache, const ParamResponsePair &search_pr, ParamResponsePair &found_pr) |
find a ParamResponsePair within a PRPMultiIndexCache based on eval_interface_ids from the ParamResponsePair search data | |
PRPQueueHIter | lookup_by_val (PRPMultiIndexQueue &prp_queue, const ParamResponsePair &search_pr) |
find a ParamResponsePair based on the interface id, variables, and ActiveSet search data within search_pr. | |
bool | lookup_by_val (PRPMultiIndexQueue &prp_queue, const ParamResponsePair &search_pr, ParamResponsePair &found_pr) |
alternate overloaded form returns bool and sets found_pr by wrapping lookup_by_val(PRPMultiIndexQueue&, ParamResponsePair&) | |
PRPQueueHIter | lookup_by_val (PRPMultiIndexQueue &prp_queue, const String &search_interface_id, const Variables &search_vars, const ActiveSet &search_set) |
find the evaluation id of a ParamResponsePair within a PRPMultiIndexQueue based on interface id, variables, and ActiveSet search data | |
bool | lookup_by_val (PRPMultiIndexQueue &prp_queue, const String &search_interface_id, const Variables &search_vars, const ActiveSet &search_set, ParamResponsePair &found_pr) |
find a ParamResponsePair within a PRPMultiIndexQueue based on interface id, variables, and ActiveSet search data | |
bool | lookup_by_val (PRPMultiIndexQueue &prp_queue, const String &search_interface_id, const Variables &search_vars, const ActiveSet &search_set, int &found_eval_id) |
find the evaluation id of a ParamResponsePair within a PRPMultiIndexQueue based on interface id, variables, and ActiveSet search data | |
bool | lookup_by_val (PRPMultiIndexQueue &prp_queue, const String &search_interface_id, const Variables &search_vars, const ActiveSet &search_set, Response &found_resp) |
find the response of a ParamResponsePair within a PRPMultiIndexQueue based on interface id, variables, and ActiveSet search data | |
PRPQueueOIter | lookup_by_eval_id (PRPMultiIndexQueue &prp_queue, const int &search_id) |
find a ParamResponsePair within a PRPMultiIndexQueue based on search_id (i.e. integer eval_id) search data | |
bool | lookup_by_eval_id (PRPMultiIndexQueue &prp_queue, const int &search_id, ParamResponsePair &found_pr) |
find a ParamResponsePair within a PRPMultiIndexQueue based on eval_id | |
bool | lookup_by_eval_id (PRPMultiIndexQueue &prp_queue, const ParamResponsePair &search_pr, ParamResponsePair &found_pr) |
find a ParamResponsePair within a PRPMultiIndexQueue based on eval_id from the ParamResponsePair search data | |
void | print_restart (int argc, char **argv, String print_dest) |
print a restart file | |
void | print_restart_tabular (int argc, char **argv, String print_dest) |
print a restart file (tabular format) | |
void | read_neutral (int argc, char **argv) |
read a restart file (neutral file format) | |
void | repair_restart (int argc, char **argv, String identifier_type) |
repair a restart file by removing corrupted evaluations | |
void | concatenate_restart (int argc, char **argv) |
concatenate multiple restart files | |
Variables | |
ParallelLibrary * | Dak_pl |
set by ParallelLibrary, for use in CLH | |
ProblemDescDB | dummy_db |
dummy ProblemDescDB object used for < mandatory reference initialization when a < real ProblemDescDB instance is unavailable | |
static Libentry | Dot_entries [] = { {"dot_"}, {"dot510_"} } |
static Libentry | Npsol_entries [] = { {"npsol_"}, {"nlssol_"}, {"npoptn2_"} } |
static Libentry | Nlpql_entries [] = { {"nlpqlp_"}, {"ql_"} } |
static SharedLib | Dot_lib = { "libdot.dll", NumberOf(Dot_entries), Dot_entries } |
static SharedLib | Npsol_lib = { "libnpsol.dll", NumberOf(Npsol_entries), Npsol_entries } |
static SharedLib | Nlpql_lib = { "libnlpql.dll", NumberOf(Nlpql_entries), Nlpql_entries } |
DOTOptimizer *(* | new_DOTOptimizer )(Model &model) = no_DOT |
DOTOptimizer *(* | new_DOTOptimizer1 )(NoDBBaseConstructor, Model &model) = no_DOT1 |
JEGAOptimizer *(* | new_JEGAOptimizer )(Model &model) = no_JEGA |
NLPQLPOptimizer *(* | new_NLPQLPOptimizer )(Model &model) = no_NLPQL |
NLPQLPOptimizer *(* | new_NLPQLPOptimizer1 )(NoDBBaseConstructor, Model &model) = no_NLPQL1 |
NPSOLOptimizer *(* | new_NPSOLOptimizer )(Model &model) = no_NPSOL |
NPSOLOptimizer *(* | new_NPSOLOptimizer1 )(NoDBBaseConstructor, Model &model) = no_NPSOL1 |
NPSOLOptimizer *(* | new_NPSOLOptimizer2 )(Model &, const int &, const Real &) = no_NPSOL2 |
NPSOLOptimizer *(* | new_NPSOLOptimizer3 )(const RealVector &initial_point, const RealVector &var_lower_bnds, const RealVector &var_upper_bnds, const RealMatrix &lin_ineq_coeffs, const RealVector &lin_ineq_lower_bnds, const RealVector &lin_ineq_upper_bnds, const RealMatrix &lin_eq_coeffs, const RealVector &lin_eq_targets, const RealVector &nonlin_ineq_lower_bnds, const RealVector &nonlin_ineq_upper_bnds, const RealVector &nonlin_eq_targets, void(*user_obj_eval)(int &, int &, double *, double &, double *, int &), void(*user_con_eval)(int &, int &, int &, int &, int *, double *, double *, double *, int &), const int &derivative_level, const Real &conv_tol) = no_NPSOL3 |
NLSSOLLeastSq *(* | new_NLSSOLLeastSq )(Model &model) = no_NLSSOL |
NLSSOLLeastSq *(* | new_NLSSOLLeastSq1 )(NoDBBaseConstructor, Model &model) = no_NLSSOL1 |
ParallelLibrary | dummy_lib |
dummy ParallelLibrary object used for < mandatory reference initialization when < a real ParallelLibrary instance is < unavailable | |
Graphics | dakota_graphics |
the global Dakota::Graphics object used by < strategies, models, and approximations | |
Interface | dummy_interface |
dummy Interface object used for mandatory < reference initialization or default virtual < function return by reference when a real < Interface instance is unavailable | |
Model | dummy_model |
dummy Model object used for mandatory reference < initialization or default virtual function < return by reference when a real Model instance < is unavailable | |
Iterator | dummy_iterator |
dummy Iterator object used for mandatory < reference initialization or default virtual < function return by reference when a real < Iterator instance is unavailable | |
const char * | FIELD_NAMES [] |
const int | NUMBER_OF_FIELDS = 25 |
PRPCache | data_pairs |
contains all parameter/response pairs. | |
Dakota_funcs * | DF |
Dakota_funcs | DakFuncs0 |
static time_t | start_time |
static char * | progname |
static int | dakdrive |
static char | slmap [256] |
static char * | wd_path [N_wdpath] |
std::ostream * | dakota_cout = &cout |
DAKOTA stdout initially points to cout, < but may be redirected to a tagged ofstream if < there are concurrent iterators. | |
std::ostream * | dakota_cerr = &cerr |
DAKOTA stderr initially points to cerr, < but may be redirected to a tagged ofstream if < there are concurrent iterators. | |
BoStream | write_restart |
the restart binary output stream (doesn't < really need to be global anymore except for < abort_handler()). | |
int | write_precision = 10 |
used in ostream data output functions < (restart_util.C overrides this default value) | |
int | mc_ptr_int = 0 |
global pointer for ModelCenter API | |
int | dc_ptr_int = 0 |
global pointer for ModelCenter eval DB | |
ProblemDescDB * | Dak_pddb |
set by ProblemDescDB, for use in parsing | |
const size_t | _NPOS = ~(size_t)0 |
special value returned by index() when entry not found | |
static GuiKeyWord | kw_1 [3] |
static GuiKeyWord | kw_2 [1] |
static GuiKeyWord | kw_3 [4] |
static GuiKeyWord | kw_4 [2] |
static GuiKeyWord | kw_5 [7] |
static GuiKeyWord | kw_6 [8] |
static GuiKeyWord | kw_7 [9] |
static GuiKeyWord | kw_8 [4] |
static GuiKeyWord | kw_9 [10] |
static GuiKeyWord | kw_10 [7] |
static GuiKeyWord | kw_11 [2] |
static GuiKeyWord | kw_12 [18] |
static GuiKeyWord | kw_13 [2] |
static GuiKeyWord | kw_14 [8] |
static GuiKeyWord | kw_15 [3] |
static GuiKeyWord | kw_16 [7] |
static GuiKeyWord | kw_17 [2] |
static GuiKeyWord | kw_18 [11] |
static GuiKeyWord | kw_19 [3] |
static GuiKeyWord | kw_20 [2] |
static GuiKeyWord | kw_21 [3] |
static GuiKeyWord | kw_22 [2] |
static GuiKeyWord | kw_23 [5] |
static GuiKeyWord | kw_24 [4] |
static GuiKeyWord | kw_25 [14] |
static GuiKeyWord | kw_26 [3] |
static GuiKeyWord | kw_27 [2] |
static GuiKeyWord | kw_28 [2] |
static GuiKeyWord | kw_29 [17] |
static GuiKeyWord | kw_30 [13] |
static GuiKeyWord | kw_31 [9] |
static GuiKeyWord | kw_32 [1] |
static GuiKeyWord | kw_33 [14] |
static GuiKeyWord | kw_34 [2] |
static GuiKeyWord | kw_35 [15] |
static GuiKeyWord | kw_36 [10] |
static GuiKeyWord | kw_37 [1] |
static GuiKeyWord | kw_38 [3] |
static GuiKeyWord | kw_39 [1] |
static GuiKeyWord | kw_40 [8] |
static GuiKeyWord | kw_41 [1] |
static GuiKeyWord | kw_42 [10] |
static GuiKeyWord | kw_43 [2] |
static GuiKeyWord | kw_44 [1] |
static GuiKeyWord | kw_45 [1] |
static GuiKeyWord | kw_46 [2] |
static GuiKeyWord | kw_47 [2] |
static GuiKeyWord | kw_48 [2] |
static GuiKeyWord | kw_49 [9] |
static GuiKeyWord | kw_50 [2] |
static GuiKeyWord | kw_51 [5] |
static GuiKeyWord | kw_52 [2] |
static GuiKeyWord | kw_53 [1] |
static GuiKeyWord | kw_54 [1] |
static GuiKeyWord | kw_55 [2] |
static GuiKeyWord | kw_56 [2] |
static GuiKeyWord | kw_57 [2] |
static GuiKeyWord | kw_58 [9] |
static GuiKeyWord | kw_59 [2] |
static GuiKeyWord | kw_60 [2] |
static GuiKeyWord | kw_61 [7] |
static GuiKeyWord | kw_62 [1] |
static GuiKeyWord | kw_63 [2] |
static GuiKeyWord | kw_64 [1] |
static GuiKeyWord | kw_65 [1] |
static GuiKeyWord | kw_66 [2] |
static GuiKeyWord | kw_67 [2] |
static GuiKeyWord | kw_68 [6] |
static GuiKeyWord | kw_69 [2] |
static GuiKeyWord | kw_70 [5] |
static GuiKeyWord | kw_71 [3] |
static GuiKeyWord | kw_72 [9] |
static GuiKeyWord | kw_73 [1] |
static GuiKeyWord | kw_74 [3] |
static GuiKeyWord | kw_75 [2] |
static GuiKeyWord | kw_76 [7] |
static GuiKeyWord | kw_77 [2] |
static GuiKeyWord | kw_78 [5] |
static GuiKeyWord | kw_79 [3] |
static GuiKeyWord | kw_80 [1] |
static GuiKeyWord | kw_81 [6] |
static GuiKeyWord | kw_82 [3] |
static GuiKeyWord | kw_83 [2] |
static GuiKeyWord | kw_84 [2] |
static GuiKeyWord | kw_85 [1] |
static GuiKeyWord | kw_86 [2] |
static GuiKeyWord | kw_87 [4] |
static GuiKeyWord | kw_88 [21] |
static GuiKeyWord | kw_89 [1] |
static GuiKeyWord | kw_90 [4] |
static GuiKeyWord | kw_91 [9] |
static GuiKeyWord | kw_92 [1] |
static GuiKeyWord | kw_93 [3] |
static GuiKeyWord | kw_94 [2] |
static GuiKeyWord | kw_95 [5] |
static GuiKeyWord | kw_96 [2] |
static GuiKeyWord | kw_97 [3] |
static GuiKeyWord | kw_98 [3] |
static GuiKeyWord | kw_99 [2] |
static GuiKeyWord | kw_100 [2] |
static GuiKeyWord | kw_101 [3] |
static GuiKeyWord | kw_102 [2] |
static GuiKeyWord | kw_103 [3] |
static GuiKeyWord | kw_104 [2] |
static GuiKeyWord | kw_105 [23] |
static GuiKeyWord | kw_106 [1] |
static GuiKeyWord | kw_107 [4] |
static GuiKeyWord | kw_108 [1] |
static GuiKeyWord | kw_109 [12] |
static GuiKeyWord | kw_110 [2] |
static GuiKeyWord | kw_111 [2] |
static GuiKeyWord | kw_112 [3] |
static GuiKeyWord | kw_113 [2] |
static GuiKeyWord | kw_114 [1] |
static GuiKeyWord | kw_115 [2] |
static GuiKeyWord | kw_116 [20] |
static GuiKeyWord | kw_117 [1] |
static GuiKeyWord | kw_118 [12] |
static GuiKeyWord | kw_119 [11] |
static GuiKeyWord | kw_120 [10] |
static GuiKeyWord | kw_121 [4] |
static GuiKeyWord | kw_122 [16] |
static GuiKeyWord | kw_123 [4] |
static GuiKeyWord | kw_124 [3] |
static GuiKeyWord | kw_125 [4] |
static GuiKeyWord | kw_126 [2] |
static GuiKeyWord | kw_127 [2] |
static GuiKeyWord | kw_128 [2] |
static GuiKeyWord | kw_129 [2] |
static GuiKeyWord | kw_130 [4] |
static GuiKeyWord | kw_131 [19] |
static GuiKeyWord | kw_132 [14] |
static GuiKeyWord | kw_133 [3] |
static GuiKeyWord | kw_134 [2] |
static GuiKeyWord | kw_135 [7] |
static GuiKeyWord | kw_136 [1] |
static GuiKeyWord | kw_137 [4] |
static GuiKeyWord | kw_138 [6] |
static GuiKeyWord | kw_139 [18] |
static GuiKeyWord | kw_140 [3] |
static GuiKeyWord | kw_141 [75] |
static GuiKeyWord | kw_142 [1] |
static GuiKeyWord | kw_143 [4] |
static GuiKeyWord | kw_144 [2] |
static GuiKeyWord | kw_145 [1] |
static GuiKeyWord | kw_146 [6] |
static GuiKeyWord | kw_147 [3] |
static GuiKeyWord | kw_148 [2] |
static GuiKeyWord | kw_149 [4] |
static GuiKeyWord | kw_150 [4] |
static GuiKeyWord | kw_151 [2] |
static GuiKeyWord | kw_152 [2] |
static GuiKeyWord | kw_153 [2] |
static GuiKeyWord | kw_154 [3] |
static GuiKeyWord | kw_155 [3] |
static GuiKeyWord | kw_156 [4] |
static GuiKeyWord | kw_157 [3] |
static GuiKeyWord | kw_158 [18] |
static GuiKeyWord | kw_159 [6] |
static GuiKeyWord | kw_160 [3] |
static GuiKeyWord | kw_161 [2] |
static GuiKeyWord | kw_162 [2] |
static GuiKeyWord | kw_163 [5] |
static GuiKeyWord | kw_164 [6] |
static GuiKeyWord | kw_165 [1] |
static GuiKeyWord | kw_166 [10] |
static GuiKeyWord | kw_167 [2] |
static GuiKeyWord | kw_168 [1] |
static GuiKeyWord | kw_169 [2] |
static GuiKeyWord | kw_170 [5] |
static GuiKeyWord | kw_171 [3] |
static GuiKeyWord | kw_172 [4] |
static GuiKeyWord | kw_173 [6] |
static GuiKeyWord | kw_174 [3] |
static GuiKeyWord | kw_175 [4] |
static GuiKeyWord | kw_176 [5] |
static GuiKeyWord | kw_177 [8] |
static GuiKeyWord | kw_178 [4] |
static GuiKeyWord | kw_179 [1] |
static GuiKeyWord | kw_180 [2] |
static GuiKeyWord | kw_181 [15] |
static GuiKeyWord | kw_182 [1] |
static GuiKeyWord | kw_183 [3] |
static GuiKeyWord | kw_184 [1] |
static GuiKeyWord | kw_185 [5] |
static GuiKeyWord | kw_186 [1] |
static GuiKeyWord | kw_187 [3] |
static GuiKeyWord | kw_188 [1] |
static GuiKeyWord | kw_189 [5] |
static GuiKeyWord | kw_190 [1] |
static GuiKeyWord | kw_191 [1] |
static GuiKeyWord | kw_192 [10] |
static GuiKeyWord | kw_193 [10] |
static GuiKeyWord | kw_194 [3] |
static GuiKeyWord | kw_195 [12] |
static GuiKeyWord | kw_196 [8] |
static GuiKeyWord | kw_197 [8] |
static GuiKeyWord | kw_198 [4] |
static GuiKeyWord | kw_199 [4] |
static GuiKeyWord | kw_200 [8] |
static GuiKeyWord | kw_201 [4] |
static GuiKeyWord | kw_202 [4] |
static GuiKeyWord | kw_203 [4] |
static GuiKeyWord | kw_204 [6] |
static GuiKeyWord | kw_205 [6] |
static GuiKeyWord | kw_206 [2] |
static GuiKeyWord | kw_207 [6] |
static GuiKeyWord | kw_208 [10] |
static GuiKeyWord | kw_209 [8] |
static GuiKeyWord | kw_210 [4] |
static GuiKeyWord | kw_211 [8] |
static GuiKeyWord | kw_212 [2] |
static GuiKeyWord | kw_213 [4] |
static GuiKeyWord | kw_214 [10] |
static GuiKeyWord | kw_215 [6] |
static GuiKeyWord | kw_216 [3] |
static GuiKeyWord | kw_217 [10] |
static GuiKeyWord | kw_218 [2] |
static GuiKeyWord | kw_219 [8] |
static GuiKeyWord | kw_220 [6] |
static GuiKeyWord | kw_221 [6] |
static GuiKeyWord | kw_222 [29] |
static GuiKeyWord | kw_223 [6] |
static KeyWord | kw_224 [8] |
static KeyWord | kw_225 [2] |
static KeyWord | kw_226 [4] |
static KeyWord | kw_227 [10] |
static KeyWord | kw_228 [6] |
static KeyWord | kw_229 [3] |
static KeyWord | kw_230 [10] |
static KeyWord | kw_231 [2] |
static KeyWord | kw_232 [8] |
static KeyWord | kw_233 [6] |
static KeyWord | kw_234 [6] |
static KeyWord | kw_235 [29] |
static KeyWord | kw_236 [6] |
FILE * | nidrin |
static const char * | aln_scaletypes [] = { "auto", "log", "none", 0 } |
static Var_uinfo | CAUVLbl [CAUVar_Nkinds] |
static Var_uinfo | DAUIVLbl [DAUIVar_Nkinds] |
static Var_uinfo | DAURVLbl [DAURVar_Nkinds] |
static Var_uinfo | CEUVLbl [CEUVar_Nkinds] |
static Var_uinfo | DiscSetLbl [DiscSetVar_Nkinds] |
static VarLabelChk | Vlch [] |
static VLstuff | VLS [N_VLS] |
static int | VL_aleatory [N_VLS] = { 1, 0, 1, 1 } |
static String | MP_ (algebraicMappings) |
static Var_bgen | var_mp_bgen [] |
static Var_bgen | var_mp_bgen_audr [] |
static Var_bgen | var_mp_bgen_audi [] |
static Var_bgen | var_mp_bgen_eu [] |
static Var_bgen | var_mp_bgen_dis [] |
static VarBgen | Bgen [] |
static Var_bchk | var_mp_bndchk [] |
static Var_ibchk | var_mp_ibndchk [] |
const int | LARGE_SCALE = 100 |
a (perhaps arbitrary) definition of large scale; choose a large-scale algorithm if numVars >= LARGE_SCALE |
The primary namespace for DAKOTA.
The COLINOptimizer class wraps COLIN, a Sandia-developed C++ optimization interface library. A variety of COLIN optimizers are defined in COLIN and its associated libraries, including SCOLIB which contains the optimization components from the old COLINY (formerly SGOPT) library. COLIN contains optimizers such as genetic algorithms, pattern search methods, and other nongradient-based techniques. COLINOptimizer uses a COLINApplication object to perform the function evaluations.
The user input mappings are as follows: max_iterations
, max_function_evaluations
, convergence_tolerance
, and solution_accuracy
are mapped into COLIN's max_iterations
, max_function_evaluations_this_trial
, function_value_tolerance
, sufficient_objective_value
properties. An outputLevel
is mapped to COLIN's output_level
property and a setting of debug
activates output of method initialization and sets the COLIN debug
attribute to 10000 for the DEBUG output level. Refer to [Hart, W.E., 2006] for additional information on COLIN objects and controls.
The Dakota namespace encapsulates the core classes of the DAKOTA framework and prevents name clashes with third-party libraries from methods and packages. The C++ source files defining these core classes reside in Dakota/src as *.[CH].
CommandShell & flush | ( | CommandShell & | shell | ) |
convenient shell manipulator function to "flush" the shell
global convenience function for manipulating the shell; invokes the class member flush function.
References CommandShell::flush().
Referenced by ForkApplicInterface::fork_application(), DirectApplicInterface::salinas(), SysCallAnalysisCode::spawn_analysis(), SysCallAnalysisCode::spawn_evaluation(), SysCallAnalysisCode::spawn_input_filter(), SysCallAnalysisCode::spawn_output_filter(), ParallelLibrary::split_communicator_dedicated_master(), and ParallelLibrary::split_communicator_peer_partition().
bool Dakota::operator== | ( | const ActiveSet & | set1, |
const ActiveSet & | set2 | ||
) |
equality operator for ActiveSet
equality operator
References ActiveSet::derivVarsVector, and ActiveSet::requestVector.
bool Dakota::operator!= | ( | const ActiveSet & | set1, |
const ActiveSet & | set2 | ||
) | [inline] |
inequality operator for ActiveSet
inequality operator
bool Dakota::operator== | ( | const ResponseRep & | rep1, |
const ResponseRep & | rep2 | ||
) |
equality operator for ResponseRep
equality operator
References ResponseRep::functionGradients, ResponseRep::functionHessians, ResponseRep::functionLabels, ResponseRep::functionValues, and ResponseRep::responseActiveSet.
bool Dakota::operator== | ( | const Response & | resp1, |
const Response & | resp2 | ||
) | [inline] |
bool Dakota::operator!= | ( | const Response & | resp1, |
const Response & | resp2 | ||
) | [inline] |
inequality operator for Response
inequality operator
bool Dakota::operator== | ( | const Variables & | vars1, |
const Variables & | vars2 | ||
) |
equality operator for Variables
equality operator
References Variables::allContinuousVars, Variables::allDiscreteIntVars, Variables::allDiscreteRealVars, Variables::sharedVarsData, Variables::variablesRep, and SharedVariablesData::view().
bool Dakota::binary_equal_to | ( | const Variables & | vars1, |
const Variables & | vars2 | ||
) |
binary_equal_to (since 'operator==' is not suitable for boost/hashed lookup)
binary_equal_to (since 'operator==' is not suitable for boost/hash_set)
References Variables::allContinuousVars, Variables::allDiscreteIntVars, Variables::allDiscreteRealVars, Variables::sharedVarsData, Variables::variablesRep, and SharedVariablesData::view().
Referenced by id_vars_exact_compare().
std::size_t Dakota::hash_value | ( | const Variables & | vars | ) |
hash_value for Variables - required by the new BMI hash_set of PRPairs
hash_value
References Variables::allContinuousVars, Variables::allDiscreteIntVars, Variables::allDiscreteRealVars, Variables::sharedVarsData, Variables::variablesRep, and SharedVariablesData::view().
Referenced by partial_prp_hash::operator()().
bool Dakota::operator!= | ( | const Variables & | vars1, |
const Variables & | vars2 | ||
) | [inline] |
inequality operator for Variables
inequality operator
void start_dakota_heartbeat | ( | int | ) |
Heartbeat function provided by not_executable.C; pass output interval in seconds, or -1 to use $DAKOTA_HEARTBEAT
Referenced by ParallelLibrary::init_mpi_comm(), and ParallelLibrary::ParallelLibrary().
Real Dakota::getdist | ( | const RealVector & | x1, |
const RealVector & | x2 | ||
) |
Gets the Euclidean distance between x1 and x2
Referenced by mindist(), and mindistindx().
Real Dakota::mindist | ( | const RealVector & | x, |
const RealMatrix & | xset, | ||
int | except | ||
) |
Real Dakota::mindistindx | ( | const RealVector & | x, |
const RealMatrix & | xset, | ||
const IntArray & | indx | ||
) |
Gets the min distance between x and points in the set xset defined by the nindx values in indx.
References getdist().
Referenced by GaussProcApproximation::pointsel_add_sel().
Real Dakota::getRmax | ( | const RealMatrix & | xset | ) |
Gets the maximum of the min distance between each point and the rest of the set.
References mindist().
Referenced by GaussProcApproximation::pointsel_add_sel().
T Dakota::abort_handler_t | ( | int | code | ) |
Templatized abort_handler_t method that allows for convenient return from methods that otherwise have no sensible return from error clauses. Usage: MyType& method() { return abort_handler<MyType&>(-1); }
References abort_handler().
int Dakota::start_grid_computing | ( | char * | analysis_driver_script, |
char * | params_file, | ||
char * | results_file | ||
) |
sample function prototype for launching grid computing
int Dakota::stop_grid_computing | ( | ) |
sample function prototype for terminating grid computing
int Dakota::perform_analysis | ( | char * | iteration_num | ) |
sample function prototype for submitting a grid evaluation
References SysCallAnalysisCode::spawn_evaluation().
string Dakota::asstring | ( | const T & | val | ) |
Creates a string from the argument val using an ostringstream.
This only gets used in this file and is only ever called with ints so no error checking is in place.
val | The value of type T to convert to a string. |
Referenced by JEGAOptimizer::LoadTheConstraints(), and JEGAOptimizer::LoadTheObjectiveFunctions().
void run_dakota_data | ( | ) |
Function to encapsulate the DAKOTA object instantiations for mode 2: direct Data class instantiation.
Rather than parsing from an input file, this function populates Data class objects directly using a minimal specification and relies on constructor defaults and post-processing in post_process() to fill in the rest.
References ProblemDescDB::broadcast(), ProblemDescDB::check_input(), DataInterface::dataIfaceRep, DataMethod::dataMethodRep, DataResponses::dataRespRep, DataVariables::dataVarsRep, DataResponsesRep::gradientType, DataResponsesRep::hessianType, ProblemDescDB::insert_node(), ProblemDescDB::lock(), DataMethodRep::methodName, model_interface_plugins(), ParallelLibrary::mpirun_flag(), DataVariablesRep::numContinuousDesVars, DataResponsesRep::numNonlinearIneqConstraints, DataResponsesRep::numObjectiveFunctions, ProblemDescDB::post_process(), Strategy::run_strategy(), and ParallelLibrary::world_rank().
Referenced by main().
bool Dakota::operator== | ( | const ParamResponsePair & | pair1, |
const ParamResponsePair & | pair2 | ||
) | [inline] |
equality operator for ParamResponsePair
equality operator
References ParamResponsePair::evalInterfaceIds, ParamResponsePair::prPairParameters, and ParamResponsePair::prPairResponse.
bool Dakota::operator!= | ( | const ParamResponsePair & | pair1, |
const ParamResponsePair & | pair2 | ||
) | [inline] |
inequality operator for ParamResponsePair
inequality operator
bool Dakota::set_compare | ( | const ParamResponsePair & | database_pr, |
const ActiveSet & | search_set | ||
) | [inline] |
search function for a particular ParamResponsePair within a PRPList based on ActiveSet content (request vector and derivative variables vector)
a global function to compare the ActiveSet of a particular database_pr (presumed to be in the global history list) with a passed in ActiveSet (search_set).
References ParamResponsePair::active_set(), ActiveSet::derivative_vector(), and ActiveSet::request_vector().
Referenced by lookup_by_val().
bool Dakota::id_vars_exact_compare | ( | const ParamResponsePair & | database_pr, |
const ParamResponsePair & | search_pr | ||
) | [inline] |
search function for a particular ParamResponsePair within a PRPMultiIndex
a global function to compare the interface id and variables of a particular database_pr (presumed to be in the global history list) with a passed in key of interface id and variables provided by search_pr.
References binary_equal_to(), ParamResponsePair::interface_id(), and ParamResponsePair::prp_parameters().
Referenced by partial_prp_equality::operator()().
PRPCacheHIter Dakota::lookup_by_val | ( | PRPMultiIndexCache & | prp_cache, |
const ParamResponsePair & | search_pr | ||
) | [inline] |
find a ParamResponsePair based on the interface id, variables, and ActiveSet search data within search_pr.
Lookup occurs in two steps: (1) PRPMultiIndexCache lookup based on strict equality in interface id and variables, and (2) set_compare() post-processing based on ActiveSet subset logic.
References ParamResponsePair::active_set(), and set_compare().
Referenced by SurrogateModel::apply_multiplicative_correction(), ApplicationInterface::duplication_detect(), Model::estimate_derivatives(), SurrBasedLocalMinimizer::find_center_approx(), lookup_by_val(), Optimizer::multi_objective_retrieve(), SNLLLeastSq::post_run(), COLINOptimizer::post_run(), SurrBasedMinimizer::print_results(), Optimizer::print_results(), LeastSq::print_results(), and NonDLocalReliability::update_mpp_search_data().
PRPQueueHIter Dakota::lookup_by_val | ( | PRPMultiIndexQueue & | prp_queue, |
const ParamResponsePair & | search_pr | ||
) | [inline] |
find a ParamResponsePair based on the interface id, variables, and ActiveSet search data within search_pr.
Lookup occurs in two steps: (1) PRPMultiIndexQueue lookup based on strict equality in interface id and variables, and (2) set_compare() post-processing based on ActiveSet subset logic.
References ParamResponsePair::active_set(), and set_compare().
void print_restart | ( | int | argc, |
char ** | argv, | ||
String | print_dest | ||
) |
print a restart file
Usage: "dakota_restart_util print dakota.rst"
"dakota_restart_util to_neutral dakota.rst dakota.neu"
Prints all evals. in full precision to either stdout or a neutral file. The former is useful for ensuring that duplicate detection is successful in a restarted run (e.g., starting a new method from the previous best), and the latter is used for translating binary files between platforms.
References ParamResponsePair::eval_id(), ParamResponsePair::write_annotated(), and write_precision.
Referenced by main().
void print_restart_tabular | ( | int | argc, |
char ** | argv, | ||
String | print_dest | ||
) |
print a restart file (tabular format)
Usage: "dakota_restart_util to_pdb dakota.rst dakota.pdb"
"dakota_restart_util to_tabular dakota.rst dakota.txt"
Unrolls all data associated with a particular tag for all evaluations and then writes this data in a tabular format (e.g., to a PDB database or MATLAB/TECPLOT data file).
References Variables::continuous_variable_labels(), Variables::continuous_variables(), String::data(), data_pairs, Variables::discrete_int_variables(), Variables::discrete_real_variables(), Response::function_values(), and ParamResponsePair::prp_parameters().
Referenced by main().
void read_neutral | ( | int | argc, |
char ** | argv | ||
) |
read a restart file (neutral file format)
Usage: "dakota_restart_util from_neutral dakota.neu dakota.rst"
Reads evaluations from a neutral file. This is used for translating binary files between platforms.
References ParamResponsePair::read_annotated(), and write_restart.
Referenced by main().
void repair_restart | ( | int | argc, |
char ** | argv, | ||
String | identifier_type | ||
) |
repair a restart file by removing corrupted evaluations
Usage: "dakota_restart_util remove 0.0 dakota_old.rst dakota_new.rst"
"dakota_restart_util remove_ids 2 7 13 dakota_old.rst
dakota_new.rst"
Repairs a restart file by removing corrupted evaluations. The identifier for evaluation removal can be either a double precision number (all evaluations having a matching response function value are removed) or a list of integers (all evaluations with matching evaluation ids are removed).
References Response::active_set_request_vector(), contains(), ParamResponsePair::eval_id(), Response::function_values(), ParamResponsePair::prp_response(), and write_restart.
Referenced by main().
void concatenate_restart | ( | int | argc, |
char ** | argv | ||
) |
concatenate multiple restart files
Usage: "dakota_restart_util cat dakota_1.rst ... dakota_n.rst dakota_new.rst"
Combines multiple restart files into a single restart database.
References write_restart.
Referenced by main().
const char* FIELD_NAMES[] |
{ "numFns", "numVars", "numACV", "numADIV", "numADRV", "numDerivVars", "xC", "xDI", "xDR", "xCLabels", "xDILabels", "xDRLabels", "directFnASV", "directFnASM", "directFnDVV", "directFnDVV_bool", "fnFlag", "gradFlag", "hessFlag", "fnVals", "fnGrads", "fnHessians", "fnLabels", "failure", "fnEvalId" }
fields to pass to Matlab in Dakota structure
Referenced by DirectApplicInterface::DirectApplicInterface(), and DirectApplicInterface::matlab_engine_run().
const int NUMBER_OF_FIELDS = 25 |
number of fields in above structure
Referenced by DirectApplicInterface::DirectApplicInterface(), and DirectApplicInterface::matlab_engine_run().
Dakota_funcs DakFuncs0 |
{ fprintf, abort_handler, dlsolver_option, continuous_lower_bounds1, continuous_upper_bounds1, nonlinear_ineq_constraint_lower_bounds1, nonlinear_ineq_constraint_upper_bounds1, nonlinear_eq_constraint_targets1, linear_ineq_constraint_lower_bounds1, linear_ineq_constraint_upper_bounds1, linear_eq_constraint_targets1, linear_ineq_constraint_coeffs1, linear_eq_constraint_coeffs1, ComputeResponses1, GetFuncs1, GetGrads1, GetContVars1, SetBestContVars1, SetBestDiscVars1, SetBestRespFns1, Get_Real1, Get_Int1, Get_Bool1 }
char slmap[256] [static] |
{ 0x0, 0x1, 0x2, 0x3, 0x4, 0x5, 0x6, 0x7, 0x8, 0x9, 0xa, 0xb, 0xc, 0xd, 0xe, 0xf, 0x10, 0x11, 0x12, 0x13, 0x14, 0x15, 0x16, 0x17, 0x18, 0x19, 0x1a, 0x1b, 0x1c, 0x1d, 0x1e, 0x1f, 0x20, 0x21, 0x22, 0x23, 0x24, 0x25, 0x26, 0x27, 0x28, 0x29, 0x2a, 0x2b, 0x2c, 0x2d, 0x2e, 0x2f, 0x30, 0x31, 0x32, 0x33, 0x34, 0x35, 0x36, 0x37, 0x38, 0x39, 0x3a, 0x3b, 0x3c, 0x3d, 0x3e, 0x3f, 0x40, 0x41, 0x42, 0x43, 0x44, 0x45, 0x46, 0x47, 0x48, 0x49, 0x4a, 0x4b, 0x4c, 0x4d, 0x4e, 0x4f, 0x50, 0x51, 0x52, 0x53, 0x54, 0x55, 0x56, 0x57, 0x58, 0x59, 0x5a, 0x5b, '/', 0x5d, 0x5e, 0x5f, 0x60, 'A', 'B', 'C', 'D', 'E', 'F', 'G', 'H', 'I', 'J', 'K', 'L', 'M', 'N', 'O', 'P', 'Q', 'R', 'S', 'T', 'U', 'V', 'W', 'X', 'Y', 'Z', 0x7b, 0x7c, 0x7d, 0x7e, 0x7f, 0x80, 0x81, 0x82, 0x83, 0x84, 0x85, 0x86, 0x87, 0x88, 0x89, 0x8a, 0x8b, 0x8c, 0x8d, 0x8e, 0x8f, 0x90, 0x91, 0x92, 0x93, 0x94, 0x95, 0x96, 0x97, 0x98, 0x99, 0x9a, 0x9b, 0x9c, 0x9d, 0x9e, 0x9f, 0xa0, 0xa1, 0xa2, 0xa3, 0xa4, 0xa5, 0xa6, 0xa7, 0xa8, 0xa9, 0xaa, 0xab, 0xac, 0xad, 0xae, 0xaf, 0xb0, 0xb1, 0xb2, 0xb3, 0xb4, 0xb5, 0xb6, 0xb7, 0xb8, 0xb9, 0xba, 0xbb, 0xbc, 0xbd, 0xbe, 0xbf, 0xc0, 0xc1, 0xc2, 0xc3, 0xc4, 0xc5, 0xc6, 0xc7, 0xc8, 0xc9, 0xca, 0xcb, 0xcc, 0xcd, 0xce, 0xcf, 0xd0, 0xd1, 0xd2, 0xd3, 0xd4, 0xd5, 0xd6, 0xd7, 0xd8, 0xd9, 0xda, 0xdb, 0xdc, 0xdd, 0xde, 0xdf, 0xe0, 0xe1, 0xe2, 0xe3, 0xe4, 0xe5, 0xe6, 0xe7, 0xe8, 0xe9, 0xea, 0xeb, 0xec, 0xed, 0xee, 0xef, 0xf0, 0xf1, 0xf2, 0xf3, 0xf4, 0xf5, 0xf6, 0xf7, 0xf8, 0xf9, 0xfa, 0xfb, 0xfc, 0xfd, 0xfe, 0xff}
static KeyWord kw_1 [static] |
{ {"active_set_vector",8,0,1,0,1567}, {"evaluation_cache",8,0,2,0,1569}, {"restart_file",8,0,3,0,1571} }
862 distinct keywords (plus 103 aliases)
static KeyWord kw_2 |
{ {"processors_per_analysis",9,0,1,0,1551,0,0.,0.,0.,0,"{Number of processors per analysis} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicDF"} }
static KeyWord kw_3 |
{ {"abort",8,0,1,1,1557,0,0.,0.,0.,0,"@[CHOOSE failure mitigation]"}, {"continuation",8,0,1,1,1563}, {"recover",14,0,1,1,1561}, {"retry",9,0,1,1,1559} }
static KeyWord kw_4 |
{ {"copy",8,0,1,0,1545,0,0.,0.,0.,0,"{Copy template files} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"}, {"replace",8,0,2,0,1547,0,0.,0.,0.,0,"{Replace existing files} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"} }
static KeyWord kw_5 |
{ {"dir_save",0,0,3,0,1538}, {"dir_tag",0,0,2,0,1536}, {"directory_save",8,0,3,0,1539,0,0.,0.,0.,0,"{Save work directory} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"}, {"directory_tag",8,0,2,0,1537,0,0.,0.,0.,0,"{Tag work directory} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"}, {"named",11,0,1,0,1535,0,0.,0.,0.,0,"{Name of work directory} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"}, {"template_directory",11,2,4,0,1541,kw_4,0.,0.,0.,0,"{Template directory} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"}, {"template_files",15,2,4,0,1543,kw_4,0.,0.,0.,0,"{Template files} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"} }
static KeyWord kw_6 |
{ {"allow_existing_results",8,0,3,0,1523,0,0.,0.,0.,0,"{Allow existing results files} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"}, {"aprepro",8,0,5,0,1527,0,0.,0.,0.,0,"{Aprepro parameters file format} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"}, {"file_save",8,0,7,0,1531,0,0.,0.,0.,0,"{Parameters and results file saving} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"}, {"file_tag",8,0,6,0,1529,0,0.,0.,0.,0,"{Parameters and results file tagging} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"}, {"parameters_file",11,0,1,0,1519,0,0.,0.,0.,0,"{Parameters file name} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"}, {"results_file",11,0,2,0,1521,0,0.,0.,0.,0,"{Results file name} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"}, {"verbatim",8,0,4,0,1525,0,0.,0.,0.,0,"{Verbatim driver/filter invocation syntax} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"}, {"work_directory",8,7,8,0,1533,kw_5,0.,0.,0.,0,"{Create work directory} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"} }
static KeyWord kw_7 |
{ {"analysis_components",15,0,1,0,1509,0,0.,0.,0.,0,"{Additional identifiers for use by the analysis_drivers} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplic"}, {"deactivate",8,3,6,0,1565,kw_1,0.,0.,0.,0,"{Feature deactivation} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplic"}, {"direct",8,1,4,1,1549,kw_2,0.,0.,0.,0,"[CHOOSE interface type]{Direct function interface } http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicDF"}, {"failure_capture",8,4,5,0,1555,kw_3,0.,0.,0.,0,"{Failure capturing} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplic"}, {"fork",8,8,4,1,1517,kw_6,0.,0.,0.,0,"@"}, {"grid",8,0,4,1,1553,0,0.,0.,0.,0,"{Grid interface } http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicG"}, {"input_filter",11,0,2,0,1511,0,0.,0.,0.,0,"{Input filter} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplic"}, {"output_filter",11,0,3,0,1513,0,0.,0.,0.,0,"{Output filter} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplic"}, {"system",8,8,4,1,1515,kw_6,0.,0.,0.,0,"{System call interface } http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplicSC"} }
static KeyWord kw_8 |
{ {"analysis_concurrency",9,0,3,0,1581,0,0.,0.,0.,0,"{Asynchronous analysis concurrency} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfIndControl"}, {"evaluation_concurrency",9,0,1,0,1575,0,0.,0.,0.,0,"{Asynchronous evaluation concurrency} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfIndControl"}, {"local_evaluation_self_scheduling",8,0,2,0,1577,0,0.,0.,0.,0,"{Self-schedule local evals} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfIndControl"}, {"local_evaluation_static_scheduling",8,0,2,0,1579,0,0.,0.,0.,0,"{Static-schedule local evals} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfIndControl"} }
static KeyWord kw_9 |
{ {"algebraic_mappings",11,0,2,0,1505,0,0.,0.,0.,0,"{Algebraic mappings file} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfAlgebraic"}, {"analysis_drivers",15,9,3,0,1507,kw_7,0.,0.,0.,0,"{Analysis drivers} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfApplic"}, {"analysis_self_scheduling",8,0,8,0,1591,0,0.,0.,0.,0,"[CHOOSE analysis sched.]{Self scheduling of analyses} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfIndControl"}, {"analysis_servers",9,0,7,0,1589,0,0.,0.,0.,0,"{Number of analysis servers} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfIndControl"}, {"analysis_static_scheduling",8,0,8,0,1593,0,0.,0.,0.,0,"{Static scheduling of analyses} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfIndControl"}, {"asynchronous",8,4,4,0,1573,kw_8,0.,0.,0.,0,"{Asynchronous interface usage} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfIndControl"}, {"evaluation_self_scheduling",8,0,6,0,1585,0,0.,0.,0.,0,"[CHOOSE evaluation sched.]{Self scheduling of evaluations} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfIndControl"}, {"evaluation_servers",9,0,5,0,1583,0,0.,0.,0.,0,"{Number of evaluation servers} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfIndControl"}, {"evaluation_static_scheduling",8,0,6,0,1587,0,0.,0.,0.,0,"{Static scheduling of evaluations} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfIndControl"}, {"id_interface",11,0,1,0,1503,0,0.,0.,0.,0,"{Interface set identifier} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/InterfCommands.html#InterfIndControl"} }
static KeyWord kw_10 |
{ {"merit1",8,0,1,1,259,0,0.,0.,0.,0,"[CHOOSE merit function]"}, {"merit1_smooth",8,0,1,1,261}, {"merit2",8,0,1,1,263}, {"merit2_smooth",8,0,1,1,265,0,0.,0.,0.,0,"@"}, {"merit2_squared",8,0,1,1,267}, {"merit_max",8,0,1,1,255}, {"merit_max_smooth",8,0,1,1,257} }
static KeyWord kw_11 |
{ {"blocking",8,0,1,1,249,0,0.,0.,0.,0,"[CHOOSE synchronization]"}, {"nonblocking",8,0,1,1,251,0,0.,0.,0.,0,"@"} }
static KeyWord kw_12 |
{ {"constraint_penalty",10,0,7,0,269,0,0.,0.,0.,0,"{Constraint penalty} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodAPPSDC"}, {"contraction_factor",10,0,2,0,241,0,0.,0.,0.,0,"{Pattern contraction factor} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodAPPSDC"}, {"initial_delta",10,0,1,0,239,0,0.,0.,0.,0,"{Initial offset value} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodAPPSDC"}, {"linear_equality_constraint_matrix",14,0,14,0,401,0,0.,0.,0.,0,"{Linear equality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scale_types",15,0,16,0,405,0,0.,0.,0.,0,"{Linear equality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scales",14,0,17,0,407,0,0.,0.,0.,0,"{Linear equality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_targets",14,0,15,0,403,0,0.,0.,0.,0,"{Linear equality targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_constraint_matrix",14,0,9,0,391,0,0.,0.,0.,0,"{Linear inequality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_lower_bounds",14,0,10,0,393,0,0.,0.,0.,0,"{Linear inequality lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scale_types",15,0,12,0,397,0,0.,0.,0.,0,"{Linear inequality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scales",14,0,13,0,399,0,0.,0.,0.,0,"{Linear inequality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_upper_bounds",14,0,11,0,395,0,0.,0.,0.,0,"{Linear inequality upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"merit_function",8,7,6,0,253,kw_10,0.,0.,0.,0,"{Merit function} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodAPPSDC"}, {"smoothing_factor",10,0,8,0,271,0,0.,0.,0.,0,"{Smoothing factor} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodAPPSDC"}, {"solution_accuracy",2,0,4,0,244}, {"solution_target",10,0,4,0,245,0,0.,0.,0.,0,"{Solution target} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodAPPSDC"}, {"synchronization",8,2,5,0,247,kw_11,0.,0.,0.,0,"{Evaluation synchronization} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodAPPSDC"}, {"threshold_delta",10,0,3,0,243,0,0.,0.,0.,0,"{Threshold for offset values} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodAPPSDC"} }
static KeyWord kw_13 |
{ {"mt19937",8,0,1,1,799}, {"rnum2",8,0,1,1,801} }
static KeyWord kw_14 |
{ {"gpmsa",8,0,1,1,795}, {"queso",8,0,1,1,793}, {"rng",8,2,2,0,797,kw_13}, {"samples",9,0,7,0,863,0,0.,0.,0.,0,"{Number of samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"seed",9,0,6,0,865,0,0.,0.,0.,0,"{Random seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"x_obs_data_file",11,0,3,0,803}, {"y_obs_data_file",11,0,4,0,805}, {"y_std_data_file",11,0,5,0,807} }
static KeyWord kw_15 |
{ {"deltas_per_variable",5,0,2,2,1046}, {"step_vector",14,0,1,1,1045,0,0.,0.,0.,0,"{Step vector} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodPSCPS"}, {"steps_per_variable",13,0,2,2,1047,0,0.,0.,0.,0,"{Number of steps per variable} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodPSCPS"} }
static KeyWord kw_16 |
{ {"initial_delta",10,0,5,1,457,0,0.,0.,0.,0,"{Initial offset value} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"misc_options",15,0,4,0,543,0,0.,0.,0.,0,"{Specify miscellaneous options} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"}, {"seed",9,0,2,0,539,0,0.,0.,0.,0,"{Random seed for stochastic pattern search} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"show_misc_options",8,0,3,0,541,0,0.,0.,0.,0,"{Show miscellaneous options} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"}, {"solution_accuracy",2,0,1,0,536}, {"solution_target",10,0,1,0,537,0,0.,0.,0.,0,"{Desired solution target} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"}, {"threshold_delta",10,0,6,2,459,0,0.,0.,0.,0,"{Threshold for offset values} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"} }
static KeyWord kw_17 |
{ {"all_dimensions",8,0,1,1,467}, {"major_dimension",8,0,1,1,465} }
static KeyWord kw_18 |
{ {"constraint_penalty",10,0,6,0,477,0,0.,0.,0.,0,"{Constraint penalty} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDIR"}, {"division",8,2,1,0,463,kw_17,0.,0.,0.,0,"{Box subdivision approach} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDIR"}, {"global_balance_parameter",10,0,2,0,469,0,0.,0.,0.,0,"{Global search balancing parameter} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDIR"}, {"local_balance_parameter",10,0,3,0,471,0,0.,0.,0.,0,"{Local search balancing parameter} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDIR"}, {"max_boxsize_limit",10,0,4,0,473,0,0.,0.,0.,0,"{Maximum boxsize limit} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDIR"}, {"min_boxsize_limit",10,0,5,0,475,0,0.,0.,0.,0,"{Minimum boxsize limit} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDIR"}, {"misc_options",15,0,10,0,543,0,0.,0.,0.,0,"{Specify miscellaneous options} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"}, {"seed",9,0,8,0,539,0,0.,0.,0.,0,"{Random seed for stochastic pattern search} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"show_misc_options",8,0,9,0,541,0,0.,0.,0.,0,"{Show miscellaneous options} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"}, {"solution_accuracy",2,0,7,0,536}, {"solution_target",10,0,7,0,537,0,0.,0.,0.,0,"{Desired solution target} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"} }
static KeyWord kw_19 |
{ {"blend",8,0,1,1,513}, {"two_point",8,0,1,1,511}, {"uniform",8,0,1,1,515} }
static KeyWord kw_20 |
{ {"linear_rank",8,0,1,1,493}, {"merit_function",8,0,1,1,495} }
static KeyWord kw_21 |
{ {"flat_file",11,0,1,1,489}, {"simple_random",8,0,1,1,485}, {"unique_random",8,0,1,1,487} }
static KeyWord kw_22 |
{ {"mutation_range",9,0,2,0,531,0,0.,0.,0.,0,"{Mutation range} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"}, {"mutation_scale",10,0,1,0,529,0,0.,0.,0.,0,"{Mutation scale} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"} }
static KeyWord kw_23 |
{ {"non_adaptive",8,0,2,0,533,0,0.,0.,0.,0,"{Non-adaptive mutation flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"}, {"offset_cauchy",8,2,1,1,525,kw_22}, {"offset_normal",8,2,1,1,523,kw_22}, {"offset_uniform",8,2,1,1,527,kw_22}, {"replace_uniform",8,0,1,1,521} }
static KeyWord kw_24 |
{ {"chc",9,0,1,1,501,0,0.,0.,0.,0,"{CHC replacement type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"}, {"elitist",9,0,1,1,503,0,0.,0.,0.,0,"{Elitist replacement type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"}, {"new_solutions_generated",9,0,2,0,505,0,0.,0.,0.,0,"{New solutions generated} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"}, {"random",9,0,1,1,499,0,0.,0.,0.,0,"{Random replacement type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"} }
static KeyWord kw_25 |
{ {"constraint_penalty",10,0,9,0,535}, {"crossover_rate",10,0,5,0,507,0,0.,0.,0.,0,"{Crossover rate} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"}, {"crossover_type",8,3,6,0,509,kw_19,0.,0.,0.,0,"{Crossover type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"}, {"fitness_type",8,2,3,0,491,kw_20,0.,0.,0.,0,"{Fitness type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"}, {"initialization_type",8,3,2,0,483,kw_21,0.,0.,0.,0,"{Initialization type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"}, {"misc_options",15,0,13,0,543,0,0.,0.,0.,0,"{Specify miscellaneous options} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"}, {"mutation_rate",10,0,7,0,517,0,0.,0.,0.,0,"{Mutation rate} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"}, {"mutation_type",8,5,8,0,519,kw_23,0.,0.,0.,0,"{Mutation type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"}, {"population_size",9,0,1,0,481,0,0.,0.,0.,0,"{Number of population members} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"}, {"replacement_type",8,4,4,0,497,kw_24,0.,0.,0.,0,"{Replacement type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYEA"}, {"seed",9,0,11,0,539,0,0.,0.,0.,0,"{Random seed for stochastic pattern search} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"show_misc_options",8,0,12,0,541,0,0.,0.,0.,0,"{Show miscellaneous options} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"}, {"solution_accuracy",2,0,10,0,536}, {"solution_target",10,0,10,0,537,0,0.,0.,0.,0,"{Desired solution target} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"} }
static KeyWord kw_26 |
{ {"adaptive_pattern",8,0,1,1,431}, {"basic_pattern",8,0,1,1,433}, {"multi_step",8,0,1,1,429} }
static KeyWord kw_27 |
{ {"coordinate",8,0,1,1,419}, {"simplex",8,0,1,1,421} }
static KeyWord kw_28 |
{ {"blocking",8,0,1,1,437}, {"nonblocking",8,0,1,1,439} }
static KeyWord kw_29 |
{ {"constant_penalty",8,0,1,0,411,0,0.,0.,0.,0,"{Control of dynamic penalty} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"constraint_penalty",10,0,16,0,453,0,0.,0.,0.,0,"{Constraint penalty} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"contraction_factor",10,0,15,0,451,0,0.,0.,0.,0,"{Pattern contraction factor} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"expand_after_success",9,0,3,0,415,0,0.,0.,0.,0,"{Number of consecutive improvements before expansion} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"exploratory_moves",8,3,7,0,427,kw_26,0.,0.,0.,0,"{Exploratory moves selection} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"initial_delta",10,0,13,1,457,0,0.,0.,0.,0,"{Initial offset value} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"misc_options",15,0,12,0,543,0,0.,0.,0.,0,"{Specify miscellaneous options} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"}, {"no_expansion",8,0,2,0,413,0,0.,0.,0.,0,"{No expansion flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"pattern_basis",8,2,4,0,417,kw_27,0.,0.,0.,0,"{Pattern basis selection} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"seed",9,0,10,0,539,0,0.,0.,0.,0,"{Random seed for stochastic pattern search} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"show_misc_options",8,0,11,0,541,0,0.,0.,0.,0,"{Show miscellaneous options} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"}, {"solution_accuracy",2,0,9,0,536}, {"solution_target",10,0,9,0,537,0,0.,0.,0.,0,"{Desired solution target} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"}, {"stochastic",8,0,5,0,423,0,0.,0.,0.,0,"{Stochastic pattern search} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"synchronization",8,2,8,0,435,kw_28,0.,0.,0.,0,"{Evaluation synchronization} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"threshold_delta",10,0,14,2,459,0,0.,0.,0.,0,"{Threshold for offset values} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"total_pattern_size",9,0,6,0,425,0,0.,0.,0.,0,"{Total number of points in pattern} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"} }
static KeyWord kw_30 |
{ {"constant_penalty",8,0,4,0,449,0,0.,0.,0.,0,"{Control of dynamic penalty} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYSW"}, {"constraint_penalty",10,0,12,0,453,0,0.,0.,0.,0,"{Constraint penalty} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"contract_after_failure",9,0,1,0,443,0,0.,0.,0.,0,"{Number of consecutive failures before contraction} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYSW"}, {"contraction_factor",10,0,11,0,451,0,0.,0.,0.,0,"{Pattern contraction factor} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"expand_after_success",9,0,3,0,447,0,0.,0.,0.,0,"{Number of consecutive improvements before expansion} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYSW"}, {"initial_delta",10,0,9,1,457,0,0.,0.,0.,0,"{Initial offset value} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"misc_options",15,0,8,0,543,0,0.,0.,0.,0,"{Specify miscellaneous options} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"}, {"no_expansion",8,0,2,0,445,0,0.,0.,0.,0,"{No expansion flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYSW"}, {"seed",9,0,6,0,539,0,0.,0.,0.,0,"{Random seed for stochastic pattern search} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"}, {"show_misc_options",8,0,7,0,541,0,0.,0.,0.,0,"{Show miscellaneous options} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"}, {"solution_accuracy",2,0,5,0,536}, {"solution_target",10,0,5,0,537,0,0.,0.,0.,0,"{Desired solution target} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYDC"}, {"threshold_delta",10,0,10,2,459,0,0.,0.,0.,0,"{Threshold for offset values} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodCOLINYPS"} }
static KeyWord kw_31 |
{ {"linear_equality_constraint_matrix",14,0,14,0,401,0,0.,0.,0.,0,"{Linear equality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scale_types",15,0,16,0,405,0,0.,0.,0.,0,"{Linear equality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scales",14,0,17,0,407,0,0.,0.,0.,0,"{Linear equality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_targets",14,0,15,0,403,0,0.,0.,0.,0,"{Linear equality targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_constraint_matrix",14,0,9,0,391,0,0.,0.,0.,0,"{Linear inequality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_lower_bounds",14,0,10,0,393,0,0.,0.,0.,0,"{Linear inequality lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scale_types",15,0,12,0,397,0,0.,0.,0.,0,"{Linear inequality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scales",14,0,13,0,399,0,0.,0.,0.,0,"{Linear inequality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_upper_bounds",14,0,11,0,395,0,0.,0.,0.,0,"{Linear inequality upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"} }
static KeyWord kw_32 |
{
{"drop_tolerance",10,0,1,0,831}
}
static KeyWord kw_33 |
{ {"box_behnken",8,0,1,1,821,0,0.,0.,0.,0,"[CHOOSE DACE type]"}, {"central_composite",8,0,1,1,823}, {"fixed_seed",8,0,5,0,833,0,0.,0.,0.,0,"{Fixed seed flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodDDACE"}, {"grid",8,0,1,1,811}, {"lhs",8,0,1,1,817}, {"main_effects",8,0,2,0,825,0,0.,0.,0.,0,"{Main effects} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodDDACE"}, {"oa_lhs",8,0,1,1,819}, {"oas",8,0,1,1,815}, {"quality_metrics",8,0,3,0,827,0,0.,0.,0.,0,"{Quality metrics} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodDDACE"}, {"random",8,0,1,1,813}, {"samples",9,0,8,0,863,0,0.,0.,0.,0,"{Number of samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"seed",9,0,7,0,865,0,0.,0.,0.,0,"{Random seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"symbols",9,0,6,0,835,0,0.,0.,0.,0,"{Number of symbols} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodDDACE"}, {"variance_based_decomp",8,1,4,0,829,kw_32,0.,0.,0.,0,"{Variance based decomposition} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodDDACE"} }
static KeyWord kw_34 |
{ {"maximize",8,0,1,1,175}, {"minimize",8,0,1,1,173} }
static KeyWord kw_35 |
{ {"bfgs",8,0,1,1,165}, {"frcg",8,0,1,1,161}, {"linear_equality_constraint_matrix",14,0,7,0,401,0,0.,0.,0.,0,"{Linear equality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scale_types",15,0,9,0,405,0,0.,0.,0.,0,"{Linear equality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scales",14,0,10,0,407,0,0.,0.,0.,0,"{Linear equality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_targets",14,0,8,0,403,0,0.,0.,0.,0,"{Linear equality targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_constraint_matrix",14,0,2,0,391,0,0.,0.,0.,0,"{Linear inequality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_lower_bounds",14,0,3,0,393,0,0.,0.,0.,0,"{Linear inequality lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scale_types",15,0,5,0,397,0,0.,0.,0.,0,"{Linear inequality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scales",14,0,6,0,399,0,0.,0.,0.,0,"{Linear inequality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_upper_bounds",14,0,4,0,395,0,0.,0.,0.,0,"{Linear inequality upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"mmfd",8,0,1,1,163}, {"optimization_type",8,2,11,0,171,kw_34,0.,0.,0.,0,"{Optimization type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodDOTDC"}, {"slp",8,0,1,1,167}, {"sqp",8,0,1,1,169} }
static KeyWord kw_36 |
{ {"linear_equality_constraint_matrix",14,0,6,0,401,0,0.,0.,0.,0,"{Linear equality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scale_types",15,0,8,0,405,0,0.,0.,0.,0,"{Linear equality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scales",14,0,9,0,407,0,0.,0.,0.,0,"{Linear equality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_targets",14,0,7,0,403,0,0.,0.,0.,0,"{Linear equality targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_constraint_matrix",14,0,1,0,391,0,0.,0.,0.,0,"{Linear inequality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_lower_bounds",14,0,2,0,393,0,0.,0.,0.,0,"{Linear inequality lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scale_types",15,0,4,0,397,0,0.,0.,0.,0,"{Linear inequality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scales",14,0,5,0,399,0,0.,0.,0.,0,"{Linear inequality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_upper_bounds",14,0,3,0,395,0,0.,0.,0.,0,"{Linear inequality upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"optimization_type",8,2,10,0,171,kw_34,0.,0.,0.,0,"{Optimization type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodDOTDC"} }
static KeyWord kw_37 |
{ {"seed",9,0,7,0,865,0,0.,0.,0.,0,"{Random seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"} }
static KeyWord kw_38 |
{ {"grid",8,0,1,1,851,0,0.,0.,0.,0,"[CHOOSE trial type]"}, {"halton",8,0,1,1,853}, {"random",8,0,1,1,855,0,0.,0.,0.,0,"@"} }
static KeyWord kw_39 |
{
{"drop_tolerance",10,0,1,0,845}
}
static KeyWord kw_40 |
{ {"fixed_seed",8,0,4,0,847,0,0.,0.,0.,0,"{Fixed seed flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"}, {"latinize",8,0,1,0,839,0,0.,0.,0.,0,"{Latinization of samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"}, {"num_trials",9,0,6,0,857,0,0.,0.,0.,0,"{Number of trials } http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"}, {"quality_metrics",8,0,2,0,841,0,0.,0.,0.,0,"{Quality metrics} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"}, {"samples",9,0,8,0,863,0,0.,0.,0.,0,"{Number of samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"seed",9,0,7,0,865,0,0.,0.,0.,0,"{Random seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"trial_type",8,3,5,0,849,kw_38,0.,0.,0.,0,"{Trial type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"}, {"variance_based_decomp",8,1,3,0,843,kw_39,0.,0.,0.,0,"{Variance based decomposition} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"} }
static KeyWord kw_41 |
{
{"drop_tolerance",10,0,1,0,1019}
}
static KeyWord kw_42 |
{ {"fixed_sequence",8,0,6,0,1023,0,0.,0.,0.,0,"{Fixed sequence flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"}, {"halton",8,0,1,1,1009,0,0.,0.,0.,0,"[CHOOSE sequence type]"}, {"hammersley",8,0,1,1,1011}, {"latinize",8,0,2,0,1013,0,0.,0.,0.,0,"{Latinization of samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"}, {"prime_base",13,0,9,0,1029,0,0.,0.,0.,0,"{Prime bases for sequences} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"}, {"quality_metrics",8,0,3,0,1015,0,0.,0.,0.,0,"{Quality metrics} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"}, {"samples",9,0,5,0,1021,0,0.,0.,0.,0,"{Number of samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"}, {"sequence_leap",13,0,8,0,1027,0,0.,0.,0.,0,"{Sequence leaping indices} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"}, {"sequence_start",13,0,7,0,1025,0,0.,0.,0.,0,"{Sequence starting indices} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"}, {"variance_based_decomp",8,1,4,0,1017,kw_41,0.,0.,0.,0,"{Variance based decomposition} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodFSUDACE"} }
static KeyWord kw_43 |
{ {"complementary",8,0,1,1,763}, {"cumulative",8,0,1,1,761} }
static KeyWord kw_44 |
{ {"num_gen_reliability_levels",13,0,1,0,771,0,0.,0.,0.,0,"{Number of generalized reliability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"} }
static KeyWord kw_45 |
{ {"num_probability_levels",13,0,1,0,767,0,0.,0.,0.,0,"{Number of probability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"} }
static KeyWord kw_46 |
{ {"mt19937",8,0,1,1,775}, {"rnum2",8,0,1,1,777} }
static KeyWord kw_47 |
{ {"gen_reliabilities",8,0,1,1,757}, {"probabilities",8,0,1,1,755} }
static KeyWord kw_48 |
{ {"compute",8,2,2,0,753,kw_47}, {"num_response_levels",13,0,1,0,751} }
static KeyWord kw_49 |
{ {"distribution",8,2,5,0,759,kw_43,0.,0.,0.,0,"{Distribution type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"ego",8,0,1,0,747}, {"gen_reliability_levels",14,1,7,0,769,kw_44,0.,0.,0.,0,"{Generalized reliability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"lhs",8,0,1,0,745}, {"probability_levels",14,1,6,0,765,kw_45,0.,0.,0.,0,"{Probability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"response_levels",14,2,2,0,749,kw_48}, {"rng",8,2,8,0,773,kw_46,0.,0.,0.,0,"{Random number generator} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"samples",9,0,4,0,863,0,0.,0.,0.,0,"{Number of samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"seed",9,0,3,0,865,0,0.,0.,0.,0,"{Random seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"} }
static KeyWord kw_50 |
{ {"mt19937",8,0,1,1,787}, {"rnum2",8,0,1,1,789} }
static KeyWord kw_51 |
{ {"ego",8,0,1,0,783}, {"lhs",8,0,1,0,781}, {"rng",8,2,2,0,785,kw_50,0.,0.,0.,0,"{Random seed generator} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDGlobalIntervalEst"}, {"samples",9,0,4,0,863,0,0.,0.,0.,0,"{Number of samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"seed",9,0,3,0,865,0,0.,0.,0.,0,"{Random seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"} }
static KeyWord kw_52 |
{ {"complementary",8,0,1,1,997}, {"cumulative",8,0,1,1,995} }
static KeyWord kw_53 |
{
{"num_gen_reliability_levels",13,0,1,0,1005}
}
static KeyWord kw_54 |
{
{"num_probability_levels",13,0,1,0,1001}
}
static KeyWord kw_55 |
{ {"gen_reliabilities",8,0,1,1,991}, {"probabilities",8,0,1,1,989} }
static KeyWord kw_56 |
{ {"compute",8,2,2,0,987,kw_55}, {"num_response_levels",13,0,1,0,985} }
static KeyWord kw_57 |
{ {"mt19937",8,0,1,1,979}, {"rnum2",8,0,1,1,981} }
static KeyWord kw_58 |
{ {"all_variables",8,0,2,0,973,0,0.,0.,0.,0,"{All variables flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDGlobalRel"}, {"distribution",8,2,6,0,993,kw_52}, {"gen_reliability_levels",14,1,8,0,1003,kw_53}, {"probability_levels",14,1,7,0,999,kw_54}, {"response_levels",14,2,5,0,983,kw_56}, {"rng",8,2,4,0,977,kw_57}, {"seed",9,0,3,0,975,0,0.,0.,0.,0,"{Random seed for initial GP construction} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDGlobalRel"}, {"u_gaussian_process",8,0,1,1,971}, {"x_gaussian_process",8,0,1,1,969} }
static KeyWord kw_59 |
{ {"gen_reliabilities",8,0,1,1,741}, {"probabilities",8,0,1,1,739} }
static KeyWord kw_60 |
{ {"compute",8,2,2,0,737,kw_59}, {"num_response_levels",13,0,1,0,735} }
static KeyWord kw_61 |
{ {"distribution",8,2,4,0,759,kw_43,0.,0.,0.,0,"{Distribution type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"gen_reliability_levels",14,1,6,0,769,kw_44,0.,0.,0.,0,"{Generalized reliability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"probability_levels",14,1,5,0,765,kw_45,0.,0.,0.,0,"{Probability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"response_levels",14,2,1,0,733,kw_60}, {"rng",8,2,7,0,773,kw_46,0.,0.,0.,0,"{Random number generator} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"samples",9,0,3,0,863,0,0.,0.,0.,0,"{Number of samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"seed",9,0,2,0,865,0,0.,0.,0.,0,"{Random seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"} }
static KeyWord kw_62 |
{ {"list_of_points",14,0,1,1,1041,0,0.,0.,0.,0,"{List of points to evaluate} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodPSLPS"} }
static KeyWord kw_63 |
{ {"complementary",8,0,1,1,903}, {"cumulative",8,0,1,1,901} }
static KeyWord kw_64 |
{
{"num_gen_reliability_levels",13,0,1,0,897}
}
static KeyWord kw_65 |
{
{"num_probability_levels",13,0,1,0,893}
}
static KeyWord kw_66 |
{ {"gen_reliabilities",8,0,1,1,889}, {"probabilities",8,0,1,1,887} }
static KeyWord kw_67 |
{ {"compute",8,2,2,0,885,kw_66}, {"num_response_levels",13,0,1,0,883} }
static KeyWord kw_68 |
{ {"distribution",8,2,5,0,899,kw_63}, {"gen_reliability_levels",14,1,4,0,895,kw_64}, {"nip",8,0,1,0,879}, {"probability_levels",14,1,3,0,891,kw_65}, {"response_levels",14,2,2,0,881,kw_67}, {"sqp",8,0,1,0,877} }
static KeyWord kw_69 |
{ {"nip",8,0,1,0,909}, {"sqp",8,0,1,0,907} }
static KeyWord kw_70 |
{ {"adapt_import",8,0,1,1,943}, {"import",8,0,1,1,941}, {"mm_adapt_import",8,0,1,1,945}, {"samples",9,0,2,0,947,0,0.,0.,0.,0,"{Refinement samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDLocalRel"}, {"seed",9,0,3,0,949,0,0.,0.,0.,0,"{Refinement seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDLocalRel"} }
static KeyWord kw_71 |
{ {"first_order",8,0,1,1,935}, {"sample_refinement",8,5,2,0,939,kw_70}, {"second_order",8,0,1,1,937} }
static KeyWord kw_72 |
{ {"nip",8,0,2,0,931}, {"no_approx",8,0,1,1,927}, {"sqp",8,0,2,0,929}, {"u_taylor_mean",8,0,1,1,917}, {"u_taylor_mpp",8,0,1,1,921}, {"u_two_point",8,0,1,1,925}, {"x_taylor_mean",8,0,1,1,915}, {"x_taylor_mpp",8,0,1,1,919}, {"x_two_point",8,0,1,1,923} }
static KeyWord kw_73 |
{
{"num_reliability_levels",13,0,1,0,965}
}
static KeyWord kw_74 |
{ {"gen_reliabilities",8,0,1,1,961}, {"probabilities",8,0,1,1,957}, {"reliabilities",8,0,1,1,959} }
static KeyWord kw_75 |
{ {"compute",8,3,2,0,955,kw_74}, {"num_response_levels",13,0,1,0,953} }
static KeyWord kw_76 |
{ {"distribution",8,2,5,0,993,kw_52}, {"gen_reliability_levels",14,1,7,0,1003,kw_53}, {"integration",8,3,2,0,933,kw_71,0.,0.,0.,0,"{Integration method} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDLocalRel"}, {"mpp_search",8,9,1,0,913,kw_72,0.,0.,0.,0,"{MPP search type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDLocalRel"}, {"probability_levels",14,1,6,0,999,kw_54}, {"reliability_levels",14,1,4,0,963,kw_73}, {"response_levels",14,2,3,0,951,kw_75} }
static KeyWord kw_77 |
{ {"num_offspring",0x19,0,2,0,369,0,0.,0.,0.,0,"{Number of offspring in random shuffle crossover} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"num_parents",0x19,0,1,0,367,0,0.,0.,0.,0,"{Number of parents in random shuffle crossover} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"} }
static KeyWord kw_78 |
{ {"crossover_rate",10,0,2,0,371,0,0.,0.,0.,0,"{Crossover rate} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"multi_point_binary",9,0,1,1,359,0,0.,0.,0.,0,"{Multi point binary crossover} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"multi_point_parameterized_binary",9,0,1,1,361,0,0.,0.,0.,0,"{Multi point parameterized binary crossover} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"multi_point_real",9,0,1,1,363,0,0.,0.,0.,0,"{Multi point real crossover} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"shuffle_random",8,2,1,1,365,kw_77,0.,0.,0.,0,"{Random shuffle crossover} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"} }
static KeyWord kw_79 |
{ {"flat_file",11,0,1,1,355}, {"simple_random",8,0,1,1,351}, {"unique_random",8,0,1,1,353} }
static KeyWord kw_80 |
{ {"mutation_scale",10,0,1,0,385,0,0.,0.,0.,0,"{Mutation scale} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"} }
static KeyWord kw_81 |
{ {"bit_random",8,0,1,1,375}, {"mutation_rate",10,0,2,0,387,0,0.,0.,0.,0,"{Mutation rate} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"offset_cauchy",8,1,1,1,381,kw_80}, {"offset_normal",8,1,1,1,379,kw_80}, {"offset_uniform",8,1,1,1,383,kw_80}, {"replace_uniform",8,0,1,1,377} }
static KeyWord kw_82 |
{ {"metric_tracker",8,0,1,1,301,0,0.,0.,0.,0,"{Convergence type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGAMOGA"}, {"num_generations",0x29,0,3,0,305,0,0.,0.,0.,0,"{Number generations for metric_tracker converger} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGAMOGA"}, {"percent_change",10,0,2,0,303,0,0.,0.,0.,0,"{Percent change limit for metric_tracker converger} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGAMOGA"} }
static KeyWord kw_83 |
{ {"domination_count",8,0,1,1,279}, {"layer_rank",8,0,1,1,277} }
static KeyWord kw_84 |
{ {"distance",14,0,1,1,297}, {"radial",14,0,1,1,295} }
static KeyWord kw_85 |
{ {"orthogonal_distance",14,0,1,1,309,0,0.,0.,0.,0,"{Post_processor distance} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGAMOGA"} }
static KeyWord kw_86 |
{ {"shrinkage_fraction",10,0,1,0,291}, {"shrinkage_percentage",2,0,1,0,290} }
static KeyWord kw_87 |
{ {"below_limit",10,2,1,1,289,kw_86,0.,0.,0.,0,"{Below limit selection} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"elitist",8,0,1,1,283}, {"roulette_wheel",8,0,1,1,285}, {"unique_roulette_wheel",8,0,1,1,287} }
static KeyWord kw_88 |
{ {"convergence_type",8,3,4,0,299,kw_82}, {"crossover_type",8,5,19,0,357,kw_78,0.,0.,0.,0,"{Crossover type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"fitness_type",8,2,1,0,275,kw_83,0.,0.,0.,0,"{Fitness type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGAMOGA"}, {"initialization_type",8,3,18,0,349,kw_79,0.,0.,0.,0,"{Initialization type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"linear_equality_constraint_matrix",14,0,11,0,401,0,0.,0.,0.,0,"{Linear equality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scale_types",15,0,13,0,405,0,0.,0.,0.,0,"{Linear equality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scales",14,0,14,0,407,0,0.,0.,0.,0,"{Linear equality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_targets",14,0,12,0,403,0,0.,0.,0.,0,"{Linear equality targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_constraint_matrix",14,0,6,0,391,0,0.,0.,0.,0,"{Linear inequality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_lower_bounds",14,0,7,0,393,0,0.,0.,0.,0,"{Linear inequality lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scale_types",15,0,9,0,397,0,0.,0.,0.,0,"{Linear inequality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scales",14,0,10,0,399,0,0.,0.,0.,0,"{Linear inequality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_upper_bounds",14,0,8,0,395,0,0.,0.,0.,0,"{Linear inequality upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"log_file",11,0,16,0,345,0,0.,0.,0.,0,"{Log file} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"mutation_type",8,6,20,0,373,kw_81,0.,0.,0.,0,"{Mutation type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"niching_type",8,2,3,0,293,kw_84,0.,0.,0.,0,"{Niche pressure type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGAMOGA"}, {"population_size",9,0,15,0,343,0,0.,0.,0.,0,"{Number of population members} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"postprocessor_type",8,1,5,0,307,kw_85,0.,0.,0.,0,"{Post_processor type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGAMOGA"}, {"print_each_pop",8,0,17,0,347,0,0.,0.,0.,0,"{Population output} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"replacement_type",8,4,2,0,281,kw_87,0.,0.,0.,0,"{Replacement type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"seed",9,0,21,0,389,0,0.,0.,0.,0,"{Random seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"} }
static KeyWord kw_89 |
{ {"partitions",13,0,1,1,1051,0,0.,0.,0.,0,"{Partitions per variable} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodPSMPS"} }
static KeyWord kw_90 |
{ {"min_boxsize_limit",10,0,2,0,871,0,0.,0.,0.,0,"{Min boxsize limit} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNCSUDC"}, {"solution_accuracy",2,0,1,0,868}, {"solution_target",10,0,1,0,869,0,0.,0.,0.,0,"{Solution Target } http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNCSUDC"}, {"volume_boxsize_limit",10,0,3,0,873} }
static KeyWord kw_91 |
{ {"absolute_conv_tol",10,0,2,0,549,0,0.,0.,0.,0,"{Absolute function convergence tolerance} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodLSNL2SOL"}, {"covariance",9,0,8,0,561,0,0.,0.,0.,0,"{Covariance post-processing} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodLSNL2SOL"}, {"false_conv_tol",10,0,6,0,557,0,0.,0.,0.,0,"{False convergence tolerance} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodLSNL2SOL"}, {"function_precision",10,0,1,0,547,0,0.,0.,0.,0,"{Relative precision in least squares terms} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodLSNL2SOL"}, {"initial_trust_radius",10,0,7,0,559,0,0.,0.,0.,0,"{Initial trust region radius} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodLSNL2SOL"}, {"regression_diagnostics",8,0,9,0,563,0,0.,0.,0.,0,"{Regression diagnostics post-processing} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodLSNL2SOL"}, {"singular_conv_tol",10,0,4,0,553,0,0.,0.,0.,0,"{Singular convergence tolerance} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodLSNL2SOL"}, {"singular_radius",10,0,5,0,555,0,0.,0.,0.,0,"{Step limit for sctol} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodLSNL2SOL"}, {"x_conv_tol",10,0,3,0,551,0,0.,0.,0.,0,"{Convergence tolerance for change in parameter vector} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodLSNL2SOL"} }
static KeyWord kw_92 |
{ {"num_reliability_levels",13,0,1,0,717,0,0.,0.,0.,0,"{Number of reliability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"} }
static KeyWord kw_93 |
{ {"gen_reliabilities",8,0,1,1,729}, {"probabilities",8,0,1,1,725}, {"reliabilities",8,0,1,1,727} }
static KeyWord kw_94 |
{ {"compute",8,3,2,0,723,kw_93,0.,0.,0.,0,"{Target statistics for response levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"num_response_levels",13,0,1,0,721,0,0.,0.,0.,0,"{Number of response levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"} }
static KeyWord kw_95 |
{ {"expansion_order",13,0,3,1,623,0,0.,0.,0.,0,"{Expansion order} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"expansion_terms",9,0,3,1,625,0,0.,0.,0.,0,"{Expansion terms} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"reuse_points",8,0,1,0,613,0,0.,0.,0.,0,"{Reuse points flag for PCE coefficient estimation by collocation_points or collocation_ratio} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"reuse_samples",0,0,1,0,612}, {"use_derivatives",8,0,2,0,615,0,0.,0.,0.,0,"{Derivative usage flag for PCE coefficient estimation by collocation_points or collocation_ratio} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"} }
static KeyWord kw_96 |
{ {"expansion_order",13,0,3,1,623,0,0.,0.,0.,0,"{Expansion order} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"expansion_terms",9,0,3,1,625,0,0.,0.,0.,0,"{Expansion terms} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"} }
static KeyWord kw_97 |
{ {"expansion_order",13,0,2,1,623,0,0.,0.,0.,0,"{Expansion order} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"expansion_terms",9,0,2,1,625,0,0.,0.,0.,0,"{Expansion terms} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"incremental_lhs",8,0,1,0,619,0,0.,0.,0.,0,"{Incremental LHS flag for PCE coefficient estimation by expansion_samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"} }
static KeyWord kw_98 |
{ {"decay",8,0,1,0,589}, {"generalized",8,0,1,0,591}, {"sobol",8,0,1,0,587} }
static KeyWord kw_99 |
{ {"adaptive",8,3,1,1,585,kw_98}, {"uniform",8,0,1,1,583} }
static KeyWord kw_100 |
{ {"nested",8,0,1,0,603}, {"non_nested",8,0,1,0,605} }
static KeyWord kw_101 |
{ {"adapt_import",8,0,1,1,637}, {"import",8,0,1,1,635}, {"mm_adapt_import",8,0,1,1,639} }
static KeyWord kw_102 |
{ {"lhs",8,0,1,1,643}, {"random",8,0,1,1,645} }
static KeyWord kw_103 |
{ {"dimension_preference",14,0,1,0,601,0,0.,0.,0.,0,"{Sparse grid dimension preference} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"nested",8,0,2,0,603}, {"non_nested",8,0,2,0,605} }
static KeyWord kw_104 |
{ {"drop_tolerance",10,0,2,0,631,0,0.,0.,0.,0,"{VBD tolerance for omitting small indices} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"univariate_effects",8,0,1,0,629,0,0.,0.,0.,0,"{Restriction of VBD indices to main/total} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"} }
static KeyWord kw_105 |
{ {"all_variables",8,0,15,0,711,0,0.,0.,0.,0,"{All variables flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"askey",8,0,2,0,593}, {"collocation_points",9,5,3,1,609,kw_95,0.,0.,0.,0,"{Number of collocation points for PCE coefficient estimation} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"collocation_ratio",10,5,3,1,611,kw_95,0.,0.,0.,0,"{Collocation point oversampling ratio for PCE coefficient estimation} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"cubature_integrand",9,0,3,1,607,0,0.,0.,0.,0,"{Cubature integrand order for PCE coefficient estimation} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"distribution",8,2,9,0,759,kw_43,0.,0.,0.,0,"{Distribution type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"expansion_import_file",11,2,3,1,621,kw_96,0.,0.,0.,0,"{File name for import of PCE coefficients} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"expansion_samples",9,3,3,1,617,kw_97,0.,0.,0.,0,"{Number of simulation samples for PCE coefficient estimation} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"fixed_seed",8,0,16,0,713,0,0.,0.,0.,0,"{Fixed seed flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"gen_reliability_levels",14,1,11,0,769,kw_44,0.,0.,0.,0,"{Generalized reliability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"p_refinement",8,2,1,0,581,kw_99,0.,0.,0.,0,"{Automated polynomial order refinement} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"probability_levels",14,1,10,0,765,kw_45,0.,0.,0.,0,"{Probability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"quadrature_order",13,2,3,1,597,kw_100,0.,0.,0.,0,"{Quadrature order for PCE coefficient estimation} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"reliability_levels",14,1,13,0,715,kw_92,0.,0.,0.,0,"{Reliability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"response_levels",14,2,14,0,719,kw_94,0.,0.,0.,0,"{Response levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"rng",8,2,12,0,773,kw_46,0.,0.,0.,0,"{Random number generator} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"sample_refinement",8,3,5,0,633,kw_101,0.,0.,0.,0,"{Importance sampling refinement} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"sample_type",8,2,6,0,641,kw_102,0.,0.,0.,0,"{Sampling type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"samples",9,0,8,0,863,0,0.,0.,0.,0,"{Number of samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"seed",9,0,7,0,865,0,0.,0.,0.,0,"{Random seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"sparse_grid_level",9,3,3,1,599,kw_103,0.,0.,0.,0,"{Sparse grid level for PCE coefficient estimation} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDPCE"}, {"variance_based_decomp",8,2,4,0,627,kw_104,0.,0.,0.,0,"{Variance based decomposition (VBD)} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"wiener",8,0,2,0,595} }
static KeyWord kw_106 |
{ {"previous_samples",9,0,1,1,705,0,0.,0.,0.,0,"{Previous samples for incremental approaches} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"} }
static KeyWord kw_107 |
{ {"incremental_lhs",8,1,1,1,701,kw_106}, {"incremental_random",8,1,1,1,703,kw_106}, {"lhs",8,0,1,1,699}, {"random",8,0,1,1,697} }
static KeyWord kw_108 |
{
{"drop_tolerance",10,0,1,0,709}
}
static KeyWord kw_109 |
{ {"all_variables",8,0,11,0,711,0,0.,0.,0.,0,"{All variables flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"distribution",8,2,5,0,759,kw_43,0.,0.,0.,0,"{Distribution type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"fixed_seed",8,0,12,0,713,0,0.,0.,0.,0,"{Fixed seed flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"gen_reliability_levels",14,1,7,0,769,kw_44,0.,0.,0.,0,"{Generalized reliability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"probability_levels",14,1,6,0,765,kw_45,0.,0.,0.,0,"{Probability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"reliability_levels",14,1,9,0,715,kw_92,0.,0.,0.,0,"{Reliability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"response_levels",14,2,10,0,719,kw_94,0.,0.,0.,0,"{Response levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"rng",8,2,8,0,773,kw_46,0.,0.,0.,0,"{Random number generator} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"sample_type",8,4,1,0,695,kw_107}, {"samples",9,0,4,0,863,0,0.,0.,0.,0,"{Number of samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"seed",9,0,3,0,865,0,0.,0.,0.,0,"{Random seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"variance_based_decomp",8,1,2,0,707,kw_108} }
static KeyWord kw_110 |
{ {"generalized",8,0,1,0,657}, {"sobol",8,0,1,0,655} }
static KeyWord kw_111 |
{ {"adaptive",8,2,1,1,653,kw_110}, {"uniform",8,0,1,1,651} }
static KeyWord kw_112 |
{ {"adapt_import",8,0,1,1,683}, {"import",8,0,1,1,681}, {"mm_adapt_import",8,0,1,1,685} }
static KeyWord kw_113 |
{ {"lhs",8,0,1,1,689}, {"random",8,0,1,1,691} }
static KeyWord kw_114 |
{ {"dimension_preference",14,0,1,0,667,0,0.,0.,0.,0,"{Sparse grid dimension preference} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDSC"} }
static KeyWord kw_115 |
{ {"drop_tolerance",10,0,2,0,677,0,0.,0.,0.,0,"{VBD tolerance for omitting small indices} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDSC"}, {"univariate_effects",8,0,1,0,675,0,0.,0.,0.,0,"{Restriction of VBD indices to main/total} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDSC"} }
static KeyWord kw_116 |
{ {"all_variables",8,0,16,0,711,0,0.,0.,0.,0,"{All variables flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"askey",8,0,2,0,659}, {"distribution",8,2,10,0,759,kw_43,0.,0.,0.,0,"{Distribution type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"fixed_seed",8,0,17,0,713,0,0.,0.,0.,0,"{Fixed seed flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"gen_reliability_levels",14,1,12,0,769,kw_44,0.,0.,0.,0,"{Generalized reliability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"nested",8,0,4,0,669}, {"non_nested",8,0,4,0,671}, {"p_refinement",8,2,1,0,649,kw_111,0.,0.,0.,0,"{Automated polynomial order refinement} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDSC"}, {"probability_levels",14,1,11,0,765,kw_45,0.,0.,0.,0,"{Probability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"quadrature_order",13,0,3,1,663,0,0.,0.,0.,0,"{Quadrature order for collocation points} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDSC"}, {"reliability_levels",14,1,14,0,715,kw_92,0.,0.,0.,0,"{Reliability levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"response_levels",14,2,15,0,719,kw_94,0.,0.,0.,0,"{Response levels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonD"}, {"rng",8,2,13,0,773,kw_46,0.,0.,0.,0,"{Random number generator} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"sample_refinement",8,3,6,0,679,kw_112,0.,0.,0.,0,"{Importance sampling refinement} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDSC"}, {"sample_type",8,2,7,0,687,kw_113,0.,0.,0.,0,"{Sampling type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDSC"}, {"samples",9,0,9,0,863,0,0.,0.,0.,0,"{Number of samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"seed",9,0,8,0,865,0,0.,0.,0.,0,"{Random seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"sparse_grid_level",9,1,3,1,665,kw_114,0.,0.,0.,0,"{Sparse grid level for collocation points} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDSC"}, {"variance_based_decomp",8,2,5,0,673,kw_115,0.,0.,0.,0,"{Variance-based decomposition (VBD)} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDSC"}, {"wiener",8,0,2,0,661} }
static KeyWord kw_117 |
{
{"misc_options",15,0,1,0,567}
}
static KeyWord kw_118 |
{ {"function_precision",10,0,11,0,195,0,0.,0.,0.,0,"{Function precision} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNPSOLDC"}, {"linear_equality_constraint_matrix",14,0,6,0,401,0,0.,0.,0.,0,"{Linear equality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scale_types",15,0,8,0,405,0,0.,0.,0.,0,"{Linear equality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scales",14,0,9,0,407,0,0.,0.,0.,0,"{Linear equality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_targets",14,0,7,0,403,0,0.,0.,0.,0,"{Linear equality targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_constraint_matrix",14,0,1,0,391,0,0.,0.,0.,0,"{Linear inequality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_lower_bounds",14,0,2,0,393,0,0.,0.,0.,0,"{Linear inequality lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scale_types",15,0,4,0,397,0,0.,0.,0.,0,"{Linear inequality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scales",14,0,5,0,399,0,0.,0.,0.,0,"{Linear inequality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_upper_bounds",14,0,3,0,395,0,0.,0.,0.,0,"{Linear inequality upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linesearch_tolerance",10,0,12,0,197,0,0.,0.,0.,0,"{Line search tolerance} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNPSOLDC"}, {"verify_level",9,0,10,0,193,0,0.,0.,0.,0,"{Gradient verification level} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNPSOLDC"} }
static KeyWord kw_119 |
{ {"gradient_tolerance",10,0,11,0,231}, {"linear_equality_constraint_matrix",14,0,6,0,401,0,0.,0.,0.,0,"{Linear equality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scale_types",15,0,8,0,405,0,0.,0.,0.,0,"{Linear equality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scales",14,0,9,0,407,0,0.,0.,0.,0,"{Linear equality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_targets",14,0,7,0,403,0,0.,0.,0.,0,"{Linear equality targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_constraint_matrix",14,0,1,0,391,0,0.,0.,0.,0,"{Linear inequality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_lower_bounds",14,0,2,0,393,0,0.,0.,0.,0,"{Linear inequality lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scale_types",15,0,4,0,397,0,0.,0.,0.,0,"{Linear inequality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scales",14,0,5,0,399,0,0.,0.,0.,0,"{Linear inequality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_upper_bounds",14,0,3,0,395,0,0.,0.,0.,0,"{Linear inequality upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"max_step",10,0,10,0,229} }
static KeyWord kw_120 |
{ {"linear_equality_constraint_matrix",14,0,7,0,401,0,0.,0.,0.,0,"{Linear equality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scale_types",15,0,9,0,405,0,0.,0.,0.,0,"{Linear equality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scales",14,0,10,0,407,0,0.,0.,0.,0,"{Linear equality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_targets",14,0,8,0,403,0,0.,0.,0.,0,"{Linear equality targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_constraint_matrix",14,0,2,0,391,0,0.,0.,0.,0,"{Linear inequality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_lower_bounds",14,0,3,0,393,0,0.,0.,0.,0,"{Linear inequality lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scale_types",15,0,5,0,397,0,0.,0.,0.,0,"{Linear inequality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scales",14,0,6,0,399,0,0.,0.,0.,0,"{Linear inequality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_upper_bounds",14,0,4,0,395,0,0.,0.,0.,0,"{Linear inequality upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"search_scheme_size",9,0,1,0,235} }
static KeyWord kw_121 |
{ {"gradient_based_line_search",8,0,1,1,215,0,0.,0.,0.,0,"[CHOOSE line search type]"}, {"tr_pds",8,0,1,1,219}, {"trust_region",8,0,1,1,217}, {"value_based_line_search",8,0,1,1,213} }
static KeyWord kw_122 |
{ {"centering_parameter",10,0,5,0,227}, {"central_path",11,0,3,0,223}, {"gradient_tolerance",10,0,16,0,231}, {"linear_equality_constraint_matrix",14,0,11,0,401,0,0.,0.,0.,0,"{Linear equality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scale_types",15,0,13,0,405,0,0.,0.,0.,0,"{Linear equality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scales",14,0,14,0,407,0,0.,0.,0.,0,"{Linear equality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_targets",14,0,12,0,403,0,0.,0.,0.,0,"{Linear equality targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_constraint_matrix",14,0,6,0,391,0,0.,0.,0.,0,"{Linear inequality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_lower_bounds",14,0,7,0,393,0,0.,0.,0.,0,"{Linear inequality lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scale_types",15,0,9,0,397,0,0.,0.,0.,0,"{Linear inequality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scales",14,0,10,0,399,0,0.,0.,0.,0,"{Linear inequality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_upper_bounds",14,0,8,0,395,0,0.,0.,0.,0,"{Linear inequality upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"max_step",10,0,15,0,229}, {"merit_function",11,0,2,0,221}, {"search_method",8,4,1,0,211,kw_121}, {"steplength_to_boundary",10,0,4,0,225} }
static KeyWord kw_123 |
{ {"debug",8,0,1,1,67,0,0.,0.,0.,0,"[CHOOSE output level]"}, {"quiet",8,0,1,1,71}, {"silent",8,0,1,1,73}, {"verbose",8,0,1,1,69} }
static KeyWord kw_124 |
{ {"partitions",13,0,1,0,861,0,0.,0.,0.,0,"{Number of partitions} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodPSUADE"}, {"samples",9,0,3,0,863,0,0.,0.,0.,0,"{Number of samples} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"}, {"seed",9,0,2,0,865,0,0.,0.,0.,0,"{Random seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNonDMC"} }
static KeyWord kw_125 |
{ {"converge_order",8,0,1,1,1057}, {"converge_qoi",8,0,1,1,1059}, {"estimate_order",8,0,1,1,1055}, {"refinement_rate",10,0,2,0,1061,0,0.,0.,0.,0,"{Refinement rate} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSolnRichardson"} }
static KeyWord kw_126 |
{ {"num_generations",0x29,0,2,0,341}, {"percent_change",10,0,1,0,339} }
static KeyWord kw_127 |
{ {"num_generations",0x29,0,2,0,335,0,0.,0.,0.,0,"{Number of generations (for convergence test) } http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGASOGA"}, {"percent_change",10,0,1,0,333,0,0.,0.,0.,0,"{Percent change in fitness} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGASOGA"} }
static KeyWord kw_128 |
{ {"average_fitness_tracker",8,2,1,1,337,kw_126}, {"best_fitness_tracker",8,2,1,1,331,kw_127} }
static KeyWord kw_129 |
{ {"constraint_penalty",10,0,2,0,317,0,0.,0.,0.,0,"{Constraint penalty in merit function} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGASOGA"}, {"merit_function",8,0,1,1,315} }
static KeyWord kw_130 |
{ {"elitist",8,0,1,1,321}, {"favor_feasible",8,0,1,1,323}, {"roulette_wheel",8,0,1,1,325}, {"unique_roulette_wheel",8,0,1,1,327} }
static KeyWord kw_131 |
{ {"convergence_type",8,2,3,0,329,kw_128,0.,0.,0.,0,"{Convergence type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGASOGA"}, {"crossover_type",8,5,17,0,357,kw_78,0.,0.,0.,0,"{Crossover type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"fitness_type",8,2,1,0,313,kw_129,0.,0.,0.,0,"{Fitness type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGASOGA"}, {"initialization_type",8,3,16,0,349,kw_79,0.,0.,0.,0,"{Initialization type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"linear_equality_constraint_matrix",14,0,9,0,401,0,0.,0.,0.,0,"{Linear equality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scale_types",15,0,11,0,405,0,0.,0.,0.,0,"{Linear equality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scales",14,0,12,0,407,0,0.,0.,0.,0,"{Linear equality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_targets",14,0,10,0,403,0,0.,0.,0.,0,"{Linear equality targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_constraint_matrix",14,0,4,0,391,0,0.,0.,0.,0,"{Linear inequality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_lower_bounds",14,0,5,0,393,0,0.,0.,0.,0,"{Linear inequality lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scale_types",15,0,7,0,397,0,0.,0.,0.,0,"{Linear inequality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scales",14,0,8,0,399,0,0.,0.,0.,0,"{Linear inequality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_upper_bounds",14,0,6,0,395,0,0.,0.,0.,0,"{Linear inequality upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"log_file",11,0,14,0,345,0,0.,0.,0.,0,"{Log file} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"mutation_type",8,6,18,0,373,kw_81,0.,0.,0.,0,"{Mutation type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"population_size",9,0,13,0,343,0,0.,0.,0.,0,"{Number of population members} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"print_each_pop",8,0,15,0,347,0,0.,0.,0.,0,"{Population output} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"}, {"replacement_type",8,4,2,0,319,kw_130,0.,0.,0.,0,"{Replacement type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGASOGA"}, {"seed",9,0,19,0,389,0,0.,0.,0.,0,"{Random seed} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodJEGADC"} }
static KeyWord kw_132 |
{ {"function_precision",10,0,12,0,195,0,0.,0.,0.,0,"{Function precision} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNPSOLDC"}, {"linear_equality_constraint_matrix",14,0,7,0,401,0,0.,0.,0.,0,"{Linear equality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scale_types",15,0,9,0,405,0,0.,0.,0.,0,"{Linear equality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scales",14,0,10,0,407,0,0.,0.,0.,0,"{Linear equality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_targets",14,0,8,0,403,0,0.,0.,0.,0,"{Linear equality targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_constraint_matrix",14,0,2,0,391,0,0.,0.,0.,0,"{Linear inequality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_lower_bounds",14,0,3,0,393,0,0.,0.,0.,0,"{Linear inequality lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scale_types",15,0,5,0,397,0,0.,0.,0.,0,"{Linear inequality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scales",14,0,6,0,399,0,0.,0.,0.,0,"{Linear inequality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_upper_bounds",14,0,4,0,395,0,0.,0.,0.,0,"{Linear inequality upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linesearch_tolerance",10,0,13,0,197,0,0.,0.,0.,0,"{Line search tolerance} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNPSOLDC"}, {"nlssol",8,0,1,1,191}, {"npsol",8,0,1,1,189}, {"verify_level",9,0,11,0,193,0,0.,0.,0.,0,"{Gradient verification level} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodNPSOLDC"} }
static KeyWord kw_133 |
{ {"approx_method_name",11,0,1,1,571,0,0.,0.,0.,0,"[CHOOSE sub-method ref.]{Approximate sub-problem minimization method name} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBG"}, {"approx_method_pointer",11,0,1,1,573,0,0.,0.,0.,0,"{Approximate sub-problem minimization method pointer} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBG"}, {"replace_points",8,0,2,0,575,0,0.,0.,0.,0,"{Replace points used in surrogate construction with best points from previous iteration} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBG"} }
static KeyWord kw_134 |
{ {"filter",8,0,1,1,143,0,0.,0.,0.,0,"@[CHOOSE acceptance logic]"}, {"tr_ratio",8,0,1,1,141} }
static KeyWord kw_135 |
{ {"augmented_lagrangian_objective",8,0,1,1,119,0,0.,0.,0.,0,"[CHOOSE objective formulation]"}, {"lagrangian_objective",8,0,1,1,121}, {"linearized_constraints",8,0,2,2,125,0,0.,0.,0.,0,"[CHOOSE constraint formulation]"}, {"no_constraints",8,0,2,2,127}, {"original_constraints",8,0,2,2,123,0,0.,0.,0.,0,"@"}, {"original_primary",8,0,1,1,115,0,0.,0.,0.,0,"@"}, {"single_objective",8,0,1,1,117} }
static KeyWord kw_136 |
{
{"homotopy",8,0,1,1,147}
}
static KeyWord kw_137 |
{ {"adaptive_penalty_merit",8,0,1,1,133,0,0.,0.,0.,0,"[CHOOSE merit function]"}, {"augmented_lagrangian_merit",8,0,1,1,137,0,0.,0.,0.,0,"@"}, {"lagrangian_merit",8,0,1,1,135}, {"penalty_merit",8,0,1,1,131} }
static KeyWord kw_138 |
{ {"contract_threshold",10,0,3,0,105,0,0.,0.,0.,0,"{Shrink trust region if trust region ratio is below this value} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"}, {"contraction_factor",10,0,5,0,109,0,0.,0.,0.,0,"{Trust region contraction factor} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"}, {"expand_threshold",10,0,4,0,107,0,0.,0.,0.,0,"{Expand trust region if trust region ratio is above this value} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"}, {"expansion_factor",10,0,6,0,111,0,0.,0.,0.,0,"{Trust region expansion factor} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"}, {"initial_size",10,0,1,0,101,0,0.,0.,0.,0,"{Trust region initial size (relative to bounds)} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"}, {"minimum_size",10,0,2,0,103,0,0.,0.,0.,0,"{Trust region minimum size} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"} }
static KeyWord kw_139 |
{ {"acceptance_logic",8,2,7,0,139,kw_134,0.,0.,0.,0,"{SBL iterate acceptance logic} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"}, {"approx_method_name",11,0,1,1,91,0,0.,0.,0.,0,"[CHOOSE sub-method ref.]{Approximate sub-problem minimization method name} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"}, {"approx_method_pointer",11,0,1,1,93,0,0.,0.,0.,0,"{Approximate sub-problem minimization method pointer} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"}, {"approx_subproblem",8,7,5,0,113,kw_135,0.,0.,0.,0,"{Approximate subproblem formulation} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"}, {"constraint_relax",8,1,8,0,145,kw_136,0.,0.,0.,0,"{SBL constraint relaxation method for infeasible iterates} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"}, {"linear_equality_constraint_matrix",14,0,14,0,401,0,0.,0.,0.,0,"{Linear equality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scale_types",15,0,16,0,405,0,0.,0.,0.,0,"{Linear equality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_scales",14,0,17,0,407,0,0.,0.,0.,0,"{Linear equality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_equality_targets",14,0,15,0,403,0,0.,0.,0.,0,"{Linear equality targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_constraint_matrix",14,0,9,0,391,0,0.,0.,0.,0,"{Linear inequality coefficient matrix} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_lower_bounds",14,0,10,0,393,0,0.,0.,0.,0,"{Linear inequality lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scale_types",15,0,12,0,397,0,0.,0.,0.,0,"{Linear inequality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_scales",14,0,13,0,399,0,0.,0.,0.,0,"{Linear inequality scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"linear_inequality_upper_bounds",14,0,11,0,395,0,0.,0.,0.,0,"{Linear inequality upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodIndControl"}, {"merit_function",8,4,6,0,129,kw_137,0.,0.,0.,0,"{SBL merit function} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"}, {"soft_convergence_limit",9,0,2,0,95,0,0.,0.,0.,0,"{Soft convergence limit for SBL iterations} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"}, {"trust_region",8,6,4,0,99,kw_138,0.,0.,0.,0,"{Trust region group specification} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"}, {"truth_surrogate_bypass",8,0,3,0,97,0,0.,0.,0.,0,"{Flag for bypassing lower level surrogates in truth verifications} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodSBL"} }
static KeyWord kw_140 |
{ {"final_point",14,0,1,1,1033,0,0.,0.,0.,0,"[CHOOSE final pt or increment]{Termination point of vector} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodPSVPS"}, {"num_steps",9,0,2,2,1037,0,0.,0.,0.,0,"{Number of steps along vector} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodPSVPS"}, {"step_vector",14,0,1,1,1035,0,0.,0.,0.,0,"{Step vector} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/MethodCommands.html#MethodPSVPS"} }
static KeyWord kw_142 |
{ {"optional_interface_responses_pointer",11,0,1,0,1223,0,0.,0.,0.,0,"{Responses pointer for nested model optional interfaces} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelNested"} }
static KeyWord kw_143 |
{ {"primary_response_mapping",14,0,3,0,1231,0,0.,0.,0.,0,"{Primary response mappings for nested models} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelNested"}, {"primary_variable_mapping",15,0,1,0,1227,0,0.,0.,0.,0,"{Primary variable mappings for nested models} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelNested"}, {"secondary_response_mapping",14,0,4,0,1233,0,0.,0.,0.,0,"{Secondary response mappings for nested models} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelNested"}, {"secondary_variable_mapping",15,0,2,0,1229,0,0.,0.,0.,0,"{Secondary variable mappings for nested models} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelNested"} }
static KeyWord kw_144 |
{ {"optional_interface_pointer",11,1,1,0,1221,kw_142,0.,0.,0.,0,"{Optional interface set pointer} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelNested"}, {"sub_method_pointer",11,4,2,1,1225,kw_143,0.,0.,0.,0,"{Sub-method pointer for nested models} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelNested"} }
static KeyWord kw_145 |
{ {"interface_pointer",11,0,1,0,1073,0,0.,0.,0.,0,"{Interface set pointer} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSingle"} }
static KeyWord kw_146 |
{ {"additive",8,0,2,2,1181,0,0.,0.,0.,0,"[CHOOSE correction type]"}, {"combined",8,0,2,2,1185}, {"first_order",8,0,1,1,1177,0,0.,0.,0.,0,"[CHOOSE correction order]"}, {"multiplicative",8,0,2,2,1183}, {"second_order",8,0,1,1,1179}, {"zeroth_order",8,0,1,1,1175} }
static KeyWord kw_147 |
{ {"constant",8,0,1,1,1087,0,0.,0.,0.,0,"[CHOOSE trend type]"}, {"linear",8,0,1,1,1089}, {"reduced_quadratic",8,0,1,1,1091} }
static KeyWord kw_148 |
{ {"point_selection",8,0,1,0,1083,0,0.,0.,0.,0,"{GP point selection} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"trend",8,3,2,0,1085,kw_147,0.,0.,0.,0,"{GP trend function} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"} }
static KeyWord kw_149 |
{ {"constant",8,0,1,1,1139}, {"linear",8,0,1,1,1141}, {"quadratic",8,0,1,1,1145}, {"reduced_quadratic",8,0,1,1,1143} }
static KeyWord kw_150 |
{ {"correlation_lengths",14,0,4,0,1151,0,0.,0.,0.,0,"{Kriging correlation lengths} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"max_trials",0x19,0,3,0,1149,0,0.,0.,0.,0,"{Kriging maximum trials} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"optimization_method",11,0,2,0,1147,0,0.,0.,0.,0,"{Kriging optimization method} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"trend",8,4,1,0,1137,kw_149,0.,0.,0.,0,"{Kriging trend function} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"} }
static KeyWord kw_151 |
{ {"cubic",8,0,1,1,1101}, {"linear",8,0,1,1,1099} }
static KeyWord kw_152 |
{ {"interpolation",8,2,2,0,1097,kw_151,0.,0.,0.,0,"{MARS interpolation} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"max_bases",9,0,1,0,1095,0,0.,0.,0.,0,"{MARS maximum bases} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"} }
static KeyWord kw_153 |
{ {"poly_order",9,0,1,0,1105,0,0.,0.,0.,0,"{MLS polynomial order} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"weight_function",9,0,2,0,1107,0,0.,0.,0.,0,"{MLS weight function} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"} }
static KeyWord kw_154 |
{ {"nodes",9,0,1,0,1111,0,0.,0.,0.,0,"{ANN number nodes} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"random_weight",9,0,3,0,1115,0,0.,0.,0.,0,"{ANN random weight} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"range",10,0,2,0,1113,0,0.,0.,0.,0,"{ANN range} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"} }
static KeyWord kw_155 |
{ {"cubic",8,0,1,1,1133,0,0.,0.,0.,0,"[CHOOSE polynomial order]"}, {"linear",8,0,1,1,1129}, {"quadratic",8,0,1,1,1131} }
static KeyWord kw_156 |
{ {"bases",9,0,1,0,1119,0,0.,0.,0.,0,"{RBF number of bases} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"max_pts",9,0,2,0,1121,0,0.,0.,0.,0,"{RBF maximum points} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"max_subsets",9,0,4,0,1125}, {"min_partition",9,0,3,0,1123,0,0.,0.,0.,0,"{RBF minimum partitions} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"} }
static KeyWord kw_157 |
{ {"all",8,0,1,1,1163}, {"none",8,0,1,1,1167}, {"region",8,0,1,1,1165} }
static KeyWord kw_158 |
{ {"correction",8,6,7,0,1173,kw_146,0.,0.,0.,0,"{Surrogate correction approach} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"dace_method_pointer",11,0,3,0,1159,0,0.,0.,0.,0,"{Design of experiments method pointer} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"diagnostics",15,0,8,0,1187,0,0.,0.,0.,0,"{Print diagnostic metrics about the surrogate goodness of fit} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"gaussian_process",8,2,1,1,1081,kw_148,0.,0.,0.,0,"[CHOOSE surrogate type]{Gaussian process} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"kriging",8,4,1,1,1135,kw_150,0.,0.,0.,0,"{Kriging interpolation} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"mars",8,2,1,1,1093,kw_152,0.,0.,0.,0,"{Multivariate adaptive regression splines} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"minimum_points",8,0,2,0,1155}, {"moving_least_squares",8,2,1,1,1103,kw_153,0.,0.,0.,0,"{Moving least squares} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"neural_network",8,3,1,1,1109,kw_154,0.,0.,0.,0,"{Artificial neural network} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"points_file",11,0,5,0,1169}, {"polynomial",8,3,1,1,1127,kw_155,0.,0.,0.,0,"{Polynomial} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"radial_basis",8,4,1,1,1117,kw_156}, {"recommended_points",8,0,2,0,1157}, {"reuse_points",8,3,4,0,1161,kw_157}, {"reuse_samples",0,3,4,0,1160,kw_157}, {"samples_file",3,0,5,0,1168}, {"total_points",9,0,2,0,1153}, {"use_derivatives",8,0,6,0,1171} }
static KeyWord kw_159 |
{ {"additive",8,0,2,2,1213,0,0.,0.,0.,0,"[CHOOSE correction type]"}, {"combined",8,0,2,2,1217}, {"first_order",8,0,1,1,1209,0,0.,0.,0.,0,"[CHOOSE correction order]"}, {"multiplicative",8,0,2,2,1215}, {"second_order",8,0,1,1,1211}, {"zeroth_order",8,0,1,1,1207} }
static KeyWord kw_160 |
{ {"correction",8,6,3,3,1205,kw_159,0.,0.,0.,0,"{Surrogate correction approach} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrH"}, {"high_fidelity_model_pointer",11,0,2,2,1203,0,0.,0.,0.,0,"{Pointer to the high fidelity model specification} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrH"}, {"low_fidelity_model_pointer",11,0,1,1,1201,0,0.,0.,0.,0,"{Pointer to the low fidelity model specification} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrH"} }
static KeyWord kw_161 |
{ {"actual_model_pointer",11,0,2,2,1197,0,0.,0.,0.,0,"{Pointer to the truth model specification} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrMP"}, {"taylor_series",8,0,1,1,1195,0,0.,0.,0.,0,"{Taylor series local approximation } http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrL"} }
static KeyWord kw_162 |
{ {"actual_model_pointer",11,0,2,2,1197,0,0.,0.,0.,0,"{Pointer to the truth model specification} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrMP"}, {"tana",8,0,1,1,1191,0,0.,0.,0.,0,"{Two-point adaptive nonlinear approximation } http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrMP"} }
static KeyWord kw_163 |
{ {"global",8,18,2,1,1079,kw_158,0.,0.,0.,0,"[CHOOSE surrogate category]{Global approximations } http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrG"}, {"hierarchical",8,3,2,1,1199,kw_160,0.,0.,0.,0,"{Hierarchical approximation } http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrH"}, {"id_surrogates",13,0,1,0,1077,0,0.,0.,0.,0,"{Surrogate response ids} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrogate"}, {"local",8,2,2,1,1193,kw_161,0.,0.,0.,0,"{Local approximation} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrL"}, {"multipoint",8,2,2,1,1189,kw_162,0.,0.,0.,0,"{Multipoint approximation} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelSurrMP"} }
static KeyWord kw_164 |
{ {"id_model",11,0,1,0,1065,0,0.,0.,0.,0,"{Model set identifier} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelIndControl"}, {"nested",8,2,4,1,1219,kw_144,0.,0.,0.,0,"[CHOOSE model type]"}, {"responses_pointer",11,0,3,0,1069,0,0.,0.,0.,0,"{Responses set pointer} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelIndControl"}, {"single",8,1,4,1,1071,kw_145,0.,0.,0.,0,"@"}, {"surrogate",8,5,4,1,1075,kw_163}, {"variables_pointer",11,0,2,0,1067,0,0.,0.,0.,0,"{Variables set pointer} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/ModelCommands.html#ModelIndControl"} }
static KeyWord kw_165 |
{ {"ignore_bounds",8,0,1,0,1673,0,0.,0.,0.,0,"{Ignore variable bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespGradMixed"} }
static KeyWord kw_166 |
{ {"central",8,0,6,0,1681,0,0.,0.,0.,0,"[CHOOSE difference interval]"}, {"dakota",8,1,4,0,1671,kw_165,0.,0.,0.,0,"@[CHOOSE gradient source]"}, {"fd_gradient_step_size",0x406,0,7,0,1682,0,0.,0.,0.001}, {"fd_step_size",0x40e,0,7,0,1683,0,0.,0.,0.001,0,"{Finite difference step size} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespGradMixed"}, {"forward",8,0,6,0,1679,0,0.,0.,0.,0,"@"}, {"id_analytic_gradients",13,0,2,2,1665,0,0.,0.,0.,0,"{Analytic derivatives function list} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespGradMixed"}, {"id_numerical_gradients",13,0,1,1,1663,0,0.,0.,0.,0,"{Numerical derivatives function list} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespGradMixed"}, {"interval_type",8,0,5,0,1677,0,0.,0.,0.,0,"{Interval type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespGradNum"}, {"method_source",8,0,3,0,1669,0,0.,0.,0.,0,"{Method source} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespGradNum"}, {"vendor",8,0,4,0,1675} }
static KeyWord kw_167 |
{ {"fd_hessian_step_size",6,0,1,0,1708}, {"fd_step_size",14,0,1,0,1709,0,0.,0.,0.,0,"{Finite difference step size} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespHessMixed"} }
static KeyWord kw_168 |
{ {"damped",8,0,1,0,1719,0,0.,0.,0.,0,"{Numerical safeguarding of BFGS update} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespHessMixed"} }
static KeyWord kw_169 |
{ {"bfgs",8,1,1,1,1717,kw_168,0.,0.,0.,0,"[CHOOSE Hessian approx.]"}, {"sr1",8,0,1,1,1721} }
static KeyWord kw_170 |
{ {"central",8,0,2,0,1713,0,0.,0.,0.,0,"[CHOOSE difference interval]"}, {"forward",8,0,2,0,1711,0,0.,0.,0.,0,"@"}, {"id_analytic_hessians",13,0,4,0,1723,0,0.,0.,0.,0,"{Analytic Hessians function list} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespHessMixed"}, {"id_numerical_hessians",13,2,1,0,1707,kw_167,0.,0.,0.,0,"{Numerical Hessians function list} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespHessMixed"}, {"id_quasi_hessians",13,2,3,0,1715,kw_169,0.,0.,0.,0,"{Quasi Hessians function list} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespHessMixed"} }
static KeyWord kw_171 |
{ {"nonlinear_equality_scale_types",0x80f,0,2,0,1651,0,0.,0.,0.,0,"{Nonlinear equality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS",0,"num_nonlinear_equality_constraints"}, {"nonlinear_equality_scales",0x80e,0,3,0,1653,0,0.,0.,0.,0,"{Nonlinear equality constraint scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS",0,"num_nonlinear_equality_constraints"}, {"nonlinear_equality_targets",14,0,1,0,1649,0,0.,0.,0.,0,"{Nonlinear equality constraint targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS",0,"num_nonlinear_equality_constraints"} }
static KeyWord kw_172 |
{ {"nonlinear_inequality_lower_bounds",14,0,1,0,1639,0,0.,0.,0.,0,"{Nonlinear inequality constraint lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS",0,"num_nonlinear_inequality_constraints"}, {"nonlinear_inequality_scale_types",0x80f,0,3,0,1643,0,0.,0.,0.,0,"{Nonlinear inequality scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS",0,"num_nonlinear_inequality_constraints"}, {"nonlinear_inequality_scales",0x80e,0,4,0,1645,0,0.,0.,0.,0,"{Nonlinear inequality constraint scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS",0,"num_nonlinear_inequality_constraints"}, {"nonlinear_inequality_upper_bounds",14,0,2,0,1641,0,0.,0.,0.,0,"{Nonlinear inequality constraint upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS",0,"num_nonlinear_inequality_constraints"} }
static KeyWord kw_173 |
{ {"least_squares_data_file",11,0,1,0,1629,0,0.,0.,0.,0,"{Least squares data source file} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS"}, {"least_squares_term_scale_types",0x80f,0,2,0,1631,0,0.,0.,0.,0,"{Least squares term scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS",0,"num_least_squares_terms"}, {"least_squares_term_scales",0x80e,0,3,0,1633,0,0.,0.,0.,0,"{Least squares terms scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS",0,"num_least_squares_terms"}, {"least_squares_weights",14,0,4,0,1635,0,0.,0.,0.,0,"{Least squares terms weightings} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS",0,"num_least_squares_terms"}, {"num_nonlinear_equality_constraints",0x29,3,6,0,1647,kw_171,0.,0.,0.,0,"{Number of nonlinear equality constraints} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS"}, {"num_nonlinear_inequality_constraints",0x29,4,5,0,1637,kw_172,0.,0.,0.,0,"{Number of nonlinear inequality constraints} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS"} }
static KeyWord kw_174 |
{ {"nonlinear_equality_scale_types",0x80f,0,2,0,1623,0,0.,0.,0.,0,"{Nonlinear equality constraint scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnOpt",0,"num_nonlinear_equality_constraints"}, {"nonlinear_equality_scales",0x80e,0,3,0,1625,0,0.,0.,0.,0,"{Nonlinear equality constraint scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnOpt",0,"num_nonlinear_equality_constraints"}, {"nonlinear_equality_targets",14,0,1,0,1621,0,0.,0.,0.,0,"{Nonlinear equality constraint targets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnOpt",0,"num_nonlinear_equality_constraints"} }
static KeyWord kw_175 |
{ {"nonlinear_inequality_lower_bounds",14,0,1,0,1611,0,0.,0.,0.,0,"{Nonlinear inequality constraint lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnOpt",0,"num_nonlinear_inequality_constraints"}, {"nonlinear_inequality_scale_types",0x80f,0,3,0,1615,0,0.,0.,0.,0,"{Nonlinear inequality constraint scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnOpt",0,"num_nonlinear_inequality_constraints"}, {"nonlinear_inequality_scales",0x80e,0,4,0,1617,0,0.,0.,0.,0,"{Nonlinear inequality constraint scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnOpt",0,"num_nonlinear_inequality_constraints"}, {"nonlinear_inequality_upper_bounds",14,0,2,0,1613,0,0.,0.,0.,0,"{Nonlinear inequality constraint upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnOpt",0,"num_nonlinear_inequality_constraints"} }
static KeyWord kw_176 |
{ {"multi_objective_weights",14,0,3,0,1607,0,0.,0.,0.,0,"{Multiobjective weightings} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnOpt",0,"num_objective_functions"}, {"num_nonlinear_equality_constraints",0x29,3,5,0,1619,kw_174,0.,0.,0.,0,"{Number of nonlinear equality constraints} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnOpt",0,"num_nonlinear_equality_constraints"}, {"num_nonlinear_inequality_constraints",0x29,4,4,0,1609,kw_175,0.,0.,0.,0,"{Number of nonlinear inequality constraints} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnOpt"}, {"objective_function_scale_types",0x80f,0,1,0,1603,0,0.,0.,0.,0,"{Objective function scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnOpt",0,"num_objective_functions"}, {"objective_function_scales",0x80e,0,2,0,1605,0,0.,0.,0.,0,"{Objective function scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnOpt",0,"num_objective_functions"} }
static KeyWord kw_177 |
{ {"central",8,0,6,0,1681,0,0.,0.,0.,0,"[CHOOSE difference interval]"}, {"dakota",8,1,4,0,1671,kw_165,0.,0.,0.,0,"@[CHOOSE gradient source]"}, {"fd_gradient_step_size",0x406,0,7,0,1682,0,0.,0.,0.001}, {"fd_step_size",0x40e,0,7,0,1683,0,0.,0.,0.001,0,"{Finite difference step size} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespGradMixed"}, {"forward",8,0,6,0,1679,0,0.,0.,0.,0,"@"}, {"interval_type",8,0,5,0,1677,0,0.,0.,0.,0,"{Interval type} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespGradNum"}, {"method_source",8,0,3,0,1669,0,0.,0.,0.,0,"{Method source} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespGradNum"}, {"vendor",8,0,4,0,1675} }
static KeyWord kw_178 |
{ {"central",8,0,2,0,1693,0,0.,0.,0.,0,"[CHOOSE difference interval]"}, {"fd_hessian_step_size",6,0,1,0,1688}, {"fd_step_size",14,0,1,0,1689,0,0.,0.,0.,0,"{Finite difference step size} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespHessNum"}, {"forward",8,0,2,0,1691,0,0.,0.,0.,0,"@"} }
static KeyWord kw_179 |
{ {"damped",8,0,1,0,1699,0,0.,0.,0.,0,"{Numerical safeguarding of BFGS update} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespHessQuasi"} }
static KeyWord kw_180 |
{ {"bfgs",8,1,1,1,1697,kw_179,0.,0.,0.,0,"[CHOOSE Hessian approx.]"}, {"sr1",8,0,1,1,1701} }
static KeyWord kw_181 |
{ {"analytic_gradients",8,0,4,2,1659,0,0.,0.,0.,0,"[CHOOSE gradient type]"}, {"analytic_hessians",8,0,5,3,1703,0,0.,0.,0.,0,"[CHOOSE Hessian type]"}, {"descriptors",15,0,2,0,1599,0,0.,0.,0.,0,"{Response labels} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespLabels"}, {"id_responses",11,0,1,0,1597,0,0.,0.,0.,0,"{Responses set identifier} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespSetId"}, {"mixed_gradients",8,10,4,2,1661,kw_166,0.,0.,0.,0,"{Mixed gradients} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespGradMixed"}, {"mixed_hessians",8,5,5,3,1705,kw_170,0.,0.,0.,0,"{Mixed Hessians} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespHessMixed"}, {"no_gradients",8,0,4,2,1657,0,0.,0.,0.,0,"@"}, {"no_hessians",8,0,5,3,1685,0,0.,0.,0.,0,"@"}, {"num_least_squares_terms",0x29,6,3,1,1627,kw_173,0.,0.,0.,0,"[CHOOSE response type]{{Least squares (calibration)} Number of least squares terms} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnLS"}, {"num_objective_functions",0x29,5,3,1,1601,kw_176,0.,0.,0.,0,"{{Optimization} Number of objective functions} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnOpt"}, {"num_response_functions",0x29,0,3,1,1655,0,0.,0.,0.,0,"{{Generic responses} Number of response functions} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespFnGen"}, {"numerical_gradients",8,8,4,2,1667,kw_177,0.,0.,0.,0,"{Numerical gradients} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespGradNum"}, {"numerical_hessians",8,4,5,3,1687,kw_178,0.,0.,0.,0,"{Numerical Hessians} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespHessNum"}, {"quasi_hessians",8,2,5,3,1695,kw_180,0.,0.,0.,0,"{Quasi Hessians} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/RespCommands.html#RespHessQuasi"}, {"response_descriptors",7,0,2,0,1598} }
static KeyWord kw_182 |
{ {"method_list",15,0,1,1,33,0,0.,0.,0.,0,"{List of methods} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratHybrid"} }
static KeyWord kw_183 |
{ {"global_method_pointer",11,0,1,1,25,0,0.,0.,0.,0,"{Pointer to the global method specification} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratHybrid"}, {"local_method_pointer",11,0,2,2,27,0,0.,0.,0.,0,"{Pointer to the local method specification} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratHybrid"}, {"local_search_probability",10,0,3,0,29,0,0.,0.,0.,0,"{Probability of executing local searches} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratHybrid"} }
static KeyWord kw_184 |
{ {"method_list",15,0,1,1,21,0,0.,0.,0.,0,"{List of methods} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratHybrid"} }
static KeyWord kw_185 |
{ {"collaborative",8,1,1,1,31,kw_182,0.,0.,0.,0,"[CHOOSE hybrid type]{Collaborative hybrid} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratHybrid"}, {"coupled",0,3,1,1,22,kw_183}, {"embedded",8,3,1,1,23,kw_183,0.,0.,0.,0,"{Embedded hybrid} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratHybrid"}, {"sequential",8,1,1,1,19,kw_184,0.,0.,0.,0,"{Sequential hybrid} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratHybrid"}, {"uncoupled",0,1,1,1,18,kw_184} }
static KeyWord kw_186 |
{ {"seed",9,0,1,0,41,0,0.,0.,0.,0,"{Seed for random starting points} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratMultiStart"} }
static KeyWord kw_187 |
{ {"method_pointer",11,0,1,1,37,0,0.,0.,0.,0,"{Method pointer} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratMultiStart"}, {"random_starts",9,1,2,0,39,kw_186,0.,0.,0.,0,"{Number of random starting points} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratMultiStart"}, {"starting_points",14,0,3,0,43,0,0.,0.,0.,0,"{List of user-specified starting points} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratMultiStart"} }
static KeyWord kw_188 |
{ {"seed",9,0,1,0,51,0,0.,0.,0.,0,"{Seed for random weighting sets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratParetoSet"} }
static KeyWord kw_189 |
{ {"method_pointer",11,0,1,1,47,0,0.,0.,0.,0,"{Optimization method pointer} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratParetoSet"}, {"multi_objective_weight_sets",6,0,3,0,52}, {"opt_method_pointer",3,0,1,1,46}, {"random_weight_sets",9,1,2,0,49,kw_188,0.,0.,0.,0,"{Number of random weighting sets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratParetoSet"}, {"weight_sets",14,0,3,0,53,0,0.,0.,0.,0,"{List of user-specified weighting sets} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratParetoSet"} }
static KeyWord kw_190 |
{ {"method_pointer",11,0,1,0,57,0,0.,0.,0.,0,"{Method pointer} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratSingle"} }
static KeyWord kw_191 |
{ {"tabular_graphics_file",11,0,1,0,7,0,0.,0.,0.,0,"{File name for tabular graphics data} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratIndControl"} }
static KeyWord kw_192 |
{ {"graphics",8,0,1,0,3,0,0.,0.,0.,0,"{Graphics flag} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratIndControl"}, {"hybrid",8,5,7,1,17,kw_185,0.,0.,0.,0,"[CHOOSE strategy type]{Hybrid strategy} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratHybrid"}, {"iterator_self_scheduling",8,0,5,0,13,0,0.,0.,0.,0,"{Self-scheduling of iterator jobs} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratIndControl"}, {"iterator_servers",9,0,4,0,11,0,0.,0.,0.,0,"{Number of iterator servers} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratIndControl"}, {"iterator_static_scheduling",8,0,6,0,15,0,0.,0.,0.,0,"{Static scheduling of iterator jobs} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratIndControl"}, {"multi_start",8,3,7,1,35,kw_187,0.,0.,0.,0,"{Multi-start iteration strategy} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratMultiStart"}, {"output_precision",0x29,0,3,0,9,0,0.,0.,0.,0,"{Numeric output precision} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratIndControl"}, {"pareto_set",8,5,7,1,45,kw_189,0.,0.,0.,0,"{Pareto set optimization strategy} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratParetoSet"}, {"single_method",8,1,7,1,55,kw_190,0.,0.,0.,0,"@{Single method strategy} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratSingle"}, {"tabular_graphics_data",8,1,2,0,5,kw_191,0.,0.,0.,0,"{Tabulation of graphics data} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/StratCommands.html#StratIndControl"} }
static KeyWord kw_193 |
{ {"alphas",14,0,1,1,1347,0,0.,0.,0.,0,"{beta uncertain alphas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Beta",0,"beta_uncertain"}, {"betas",14,0,2,2,1349,0,0.,0.,0.,0,"{beta uncertain betas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Beta",0,"beta_uncertain"}, {"buv_alphas",6,0,1,1,1346,0,0.,0.,0.,0,0,0,"beta_uncertain"}, {"buv_betas",6,0,2,2,1348,0,0.,0.,0.,0,0,0,"beta_uncertain"}, {"buv_descriptors",7,0,5,0,1354,0,0.,0.,0.,0,0,0,"beta_uncertain"}, {"buv_lower_bounds",6,0,3,3,1350,0,0.,0.,0.,0,0,0,"beta_uncertain"}, {"buv_upper_bounds",6,0,4,4,1352,0,0.,0.,0.,0,0,0,"beta_uncertain"}, {"descriptors",15,0,5,0,1355,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Beta",0,"beta_uncertain"}, {"lower_bounds",14,0,3,3,1351,0,0.,0.,0.,0,"{Distribution lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Beta",0,"beta_uncertain"}, {"upper_bounds",14,0,4,4,1353,0,0.,0.,0.,0,"{Distribution upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Beta",0,"beta_uncertain"} }
static KeyWord kw_194 |
{ {"descriptors",15,0,3,0,1413,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Binomial",0,"binomial_uncertain"}, {"num_trials",13,0,2,2,1411,0,0.,0.,0.,0,"{binomial uncertain num_trials} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Binomial",0,"binomial_uncertain"}, {"prob_per_trial",14,0,1,1,1409,0,0.,0.,0.,0,"{binomial uncertain prob_per_trial} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Binomial",0,"binomial_uncertain"} }
static KeyWord kw_195 |
{ {"cdv_descriptors",7,0,6,0,1250,0,0.,0.,0.,0,0,0,"continuous_design"}, {"cdv_initial_point",6,0,1,0,1240,0,0.,0.,0.,0,0,0,"continuous_design"}, {"cdv_lower_bounds",6,0,2,0,1242,0,0.,0.,0.,0,0,0,"continuous_design"}, {"cdv_scale_types",0x807,0,4,0,1246,0,0.,0.,0.,0,0,0,"continuous_design"}, {"cdv_scales",0x806,0,5,0,1248,0,0.,0.,0.,0,0,0,"continuous_design"}, {"cdv_upper_bounds",6,0,3,0,1244,0,0.,0.,0.,0,0,0,"continuous_design"}, {"descriptors",15,0,6,0,1251,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCDV",0,"continuous_design"}, {"initial_point",14,0,1,0,1241,0,0.,0.,0.,0,"{Initial point} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCDV",0,"continuous_design"}, {"lower_bounds",14,0,2,0,1243,0,0.,0.,0.,0,"{Lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCDV",0,"continuous_design"}, {"scale_types",0x80f,0,4,0,1247,0,0.,0.,0.,0,"{Scaling types} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCDV",0,"continuous_design"}, {"scales",0x80e,0,5,0,1249,0,0.,0.,0.,0,"{Scales} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCDV",0,"continuous_design"}, {"upper_bounds",14,0,3,0,1245,0,0.,0.,0.,0,"{Upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCDV",0,"continuous_design"} }
static KeyWord kw_196 |
{ {"csv_descriptors",7,0,4,0,1468,0,0.,0.,0.,0,0,0,"continuous_state"}, {"csv_initial_state",6,0,1,0,1462,0,0.,0.,0.,0,0,0,"continuous_state"}, {"csv_lower_bounds",6,0,2,0,1464,0,0.,0.,0.,0,0,0,"continuous_state"}, {"csv_upper_bounds",6,0,3,0,1466,0,0.,0.,0.,0,0,0,"continuous_state"}, {"descriptors",15,0,4,0,1469,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCSV",0,"continuous_state"}, {"initial_state",14,0,1,0,1463,0,0.,0.,0.,0,"{Initial states} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCSV",0,"continuous_state"}, {"lower_bounds",14,0,2,0,1465,0,0.,0.,0.,0,"{Lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCSV",0,"continuous_state"}, {"upper_bounds",14,0,3,0,1467,0,0.,0.,0.,0,"{Upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCSV",0,"continuous_state"} }
static KeyWord kw_197 |
{ {"ddv_descriptors",7,0,4,0,1260,0,0.,0.,0.,0,0,0,"discrete_design_range"}, {"ddv_initial_point",5,0,1,0,1254,0,0.,0.,0.,0,0,0,"discrete_design_range"}, {"ddv_lower_bounds",5,0,2,0,1256,0,0.,0.,0.,0,0,0,"discrete_design_range"}, {"ddv_upper_bounds",5,0,3,0,1258,0,0.,0.,0.,0,0,0,"discrete_design_range"}, {"descriptors",15,0,4,0,1261,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDDRIV",0,"discrete_design_range"}, {"initial_point",13,0,1,0,1255,0,0.,0.,0.,0,"{Initial point} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDDRIV",0,"discrete_design_range"}, {"lower_bounds",13,0,2,0,1257,0,0.,0.,0.,0,"{Lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDDRIV",0,"discrete_design_range"}, {"upper_bounds",13,0,3,0,1259,0,0.,0.,0.,0,"{Upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDDRIV",0,"discrete_design_range"} }
static KeyWord kw_198 |
{ {"descriptors",15,0,4,0,1271,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDDSIV",0,"discrete_design_set_integer"}, {"initial_point",13,0,1,0,1265,0,0.,0.,0.,0,"{Initial point} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDDSIV",0,"discrete_design_set_integer"}, {"num_set_values",13,0,2,0,1267,0,0.,0.,0.,0,"{Number of values for each variable} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDDSIV",0,"discrete_design_set_integer"}, {"set_values",13,0,3,1,1269,0,0.,0.,0.,0,"{Set values} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDDSIV"} }
static KeyWord kw_199 |
{ {"descriptors",15,0,4,0,1281,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDDSRV",0,"discrete_design_set_real"}, {"initial_point",14,0,1,0,1275,0,0.,0.,0.,0,"{Initial point} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDDSRV",0,"discrete_design_set_real"}, {"num_set_values",13,0,2,0,1277,0,0.,0.,0.,0,"{Number of values for each variable} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDDSRV",0,"discrete_design_set_real"}, {"set_values",14,0,3,1,1279,0,0.,0.,0.,0,"{Set values} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDDSRV"} }
static KeyWord kw_200 |
{ {"descriptors",15,0,4,0,1479,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDSRIV",0,"discrete_state_range"}, {"dsv_descriptors",7,0,4,0,1478,0,0.,0.,0.,0,0,0,"discrete_state_range"}, {"dsv_initial_state",5,0,1,0,1472,0,0.,0.,0.,0,0,0,"discrete_state_range"}, {"dsv_lower_bounds",5,0,2,0,1474,0,0.,0.,0.,0,0,0,"discrete_state_range"}, {"dsv_upper_bounds",5,0,3,0,1476,0,0.,0.,0.,0,0,0,"discrete_state_range"}, {"initial_state",13,0,1,0,1473,0,0.,0.,0.,0,"{Initial states} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDSRIV",0,"discrete_state_range"}, {"lower_bounds",13,0,2,0,1475,0,0.,0.,0.,0,"{Lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDSRIV",0,"discrete_state_range"}, {"upper_bounds",13,0,3,0,1477,0,0.,0.,0.,0,"{Upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDSRIV",0,"discrete_state_range"} }
static KeyWord kw_201 |
{ {"descriptors",15,0,4,0,1489,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDSSIV",0,"discrete_state_set_integer"}, {"initial_state",13,0,1,0,1483,0,0.,0.,0.,0,"{Initial state} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDSSIV",0,"discrete_state_set_integer"}, {"num_set_values",13,0,2,0,1485,0,0.,0.,0.,0,"{Number of values for each variable} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDSSIV",0,"discrete_state_set_integer"}, {"set_values",13,0,3,1,1487,0,0.,0.,0.,0,"{Set values} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDSSIV"} }
static KeyWord kw_202 |
{ {"descriptors",15,0,4,0,1499,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDSSRV",0,"discrete_state_set_real"}, {"initial_state",14,0,1,0,1493,0,0.,0.,0.,0,"{Initial state} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDSSRV",0,"discrete_state_set_real"}, {"num_set_values",13,0,2,0,1495,0,0.,0.,0.,0,"{Number of values for each variable} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDSSRV",0,"discrete_state_set_real"}, {"set_values",14,0,3,1,1497,0,0.,0.,0.,0,"{Set values} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDSSRV"} }
static KeyWord kw_203 |
{ {"betas",14,0,1,1,1341,0,0.,0.,0.,0,"{exponential uncertain betas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Exponential",0,"exponential_uncertain"}, {"descriptors",15,0,2,0,1343,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Exponential",0,"exponential_uncertain"}, {"euv_betas",6,0,1,1,1340,0,0.,0.,0.,0,0,0,"exponential_uncertain"}, {"euv_descriptors",7,0,2,0,1342,0,0.,0.,0.,0,0,0,"exponential_uncertain"} }
static KeyWord kw_204 |
{ {"alphas",14,0,1,1,1375,0,0.,0.,0.,0,"{frechet uncertain alphas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Frechet",0,"frechet_uncertain"}, {"betas",14,0,2,2,1377,0,0.,0.,0.,0,"{frechet uncertain betas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Frechet",0,"frechet_uncertain"}, {"descriptors",15,0,3,0,1379,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Frechet",0,"frechet_uncertain"}, {"fuv_alphas",6,0,1,1,1374,0,0.,0.,0.,0,0,0,"frechet_uncertain"}, {"fuv_betas",6,0,2,2,1376,0,0.,0.,0.,0,0,0,"frechet_uncertain"}, {"fuv_descriptors",7,0,3,0,1378,0,0.,0.,0.,0,0,0,"frechet_uncertain"} }
static KeyWord kw_205 |
{ {"alphas",14,0,1,1,1359,0,0.,0.,0.,0,"{gamma uncertain alphas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Gamma",0,"gamma_uncertain"}, {"betas",14,0,2,2,1361,0,0.,0.,0.,0,"{gamma uncertain betas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Gamma",0,"gamma_uncertain"}, {"descriptors",15,0,3,0,1363,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Gamma",0,"gamma_uncertain"}, {"gauv_alphas",6,0,1,1,1358,0,0.,0.,0.,0,0,0,"gamma_uncertain"}, {"gauv_betas",6,0,2,2,1360,0,0.,0.,0.,0,0,0,"gamma_uncertain"}, {"gauv_descriptors",7,0,3,0,1362,0,0.,0.,0.,0,0,0,"gamma_uncertain"} }
static KeyWord kw_206 |
{ {"descriptors",15,0,2,0,1427,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Geometric",0,"geometric_uncertain"}, {"prob_per_trial",14,0,1,1,1425,0,0.,0.,0.,0,"{geometric uncertain prob_per_trial} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Geometric",0,"geometric_uncertain"} }
static KeyWord kw_207 |
{ {"alphas",14,0,1,1,1367,0,0.,0.,0.,0,"{gumbel uncertain alphas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Gumbel",0,"gumbel_uncertain"}, {"betas",14,0,2,2,1369,0,0.,0.,0.,0,"{gumbel uncertain betas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Gumbel",0,"gumbel_uncertain"}, {"descriptors",15,0,3,0,1371,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Gumbel",0,"gumbel_uncertain"}, {"guuv_alphas",6,0,1,1,1366,0,0.,0.,0.,0,0,0,"gumbel_uncertain"}, {"guuv_betas",6,0,2,2,1368,0,0.,0.,0.,0,0,0,"gumbel_uncertain"}, {"guuv_descriptors",7,0,3,0,1370,0,0.,0.,0.,0,0,0,"gumbel_uncertain"} }
static KeyWord kw_208 |
{ {"abscissas",14,0,2,1,1393,0,0.,0.,0.,0,"{sets of abscissas for bin-based histogram variables} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Bin_Histogram"}, {"counts",14,0,3,2,1397,0,0.,0.,0.,0,"{sets of counts for bin-based histogram variables} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Bin_Histogram"}, {"descriptors",15,0,4,0,1399,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Bin_Histogram",0,"histogram_bin_uncertain"}, {"huv_bin_abscissas",6,0,2,1,1392}, {"huv_bin_counts",6,0,3,2,1396}, {"huv_bin_descriptors",7,0,4,0,1398,0,0.,0.,0.,0,0,0,"histogram_bin_uncertain"}, {"huv_bin_ordinates",6,0,3,2,1394}, {"huv_num_bin_pairs",5,0,1,0,1390,0,0.,0.,0.,0,0,0,"histogram_bin_uncertain"}, {"num_pairs",13,0,1,0,1391,0,0.,0.,0.,0,"{key to apportionment among bin-based histogram variables} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Bin_Histogram",0,"histogram_bin_uncertain"}, {"ordinates",14,0,3,2,1395,0,0.,0.,0.,0,"{sets of ordinates for bin-based histogram variables} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Bin_Histogram"} }
static KeyWord kw_209 |
{ {"abscissas",14,0,2,1,1443,0,0.,0.,0.,0,"{sets of abscissas for point-based histogram variables} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Point_Histogram"}, {"counts",14,0,3,2,1445,0,0.,0.,0.,0,"{sets of counts for point-based histogram variables} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Point_Histogram"}, {"descriptors",15,0,4,0,1447,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Point_Histogram",0,"histogram_point_uncertain"}, {"huv_num_point_pairs",5,0,1,0,1440,0,0.,0.,0.,0,0,0,"histogram_point_uncertain"}, {"huv_point_abscissas",6,0,2,1,1442}, {"huv_point_counts",6,0,3,2,1444}, {"huv_point_descriptors",7,0,4,0,1446,0,0.,0.,0.,0,0,0,"histogram_point_uncertain"}, {"num_pairs",13,0,1,0,1441,0,0.,0.,0.,0,"{key to apportionment among point-based histogram variables} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Point_Histogram",0,"histogram_point_uncertain"} }
static KeyWord kw_210 |
{ {"descriptors",15,0,4,0,1437,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Hypergeometric",0,"hypergeometric_uncertain"}, {"num_drawn",13,0,3,3,1435,0,0.,0.,0.,0,"{hypergeometric uncertain num_drawn } http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Hypergeometric",0,"hypergeometric_uncertain"}, {"selected_population",13,0,2,2,1433,0,0.,0.,0.,0,"{hypergeometric uncertain selected_population} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Hypergeometric",0,"hypergeometric_uncertain"}, {"total_population",13,0,1,1,1431,0,0.,0.,0.,0,"{hypergeometric uncertain total_population} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Hypergeometric",0,"hypergeometric_uncertain"} }
static KeyWord kw_211 |
{ {"descriptors",15,0,4,0,1459,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCEUV_Interval",0,"interval_uncertain"}, {"interval_bounds",14,0,3,2,1457,0,0.,0.,0.,0,"{bounds per interval} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCEUV_Interval"}, {"interval_probs",14,0,2,1,1455,0,0.,0.,0.,0,"{basic probability assignments per interval} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCEUV_Interval"}, {"iuv_descriptors",7,0,4,0,1458,0,0.,0.,0.,0,0,0,"interval_uncertain"}, {"iuv_interval_bounds",6,0,3,2,1456}, {"iuv_interval_probs",6,0,2,1,1454}, {"iuv_num_intervals",5,0,1,0,1452,0,0.,0.,0.,0,0,0,"interval_uncertain"}, {"num_intervals",13,0,1,0,1453,0,0.,0.,0.,0,"{number of intervals defined for each interval variable} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCEUV_Interval",0,"interval_uncertain"} }
static KeyWord kw_212 |
{ {"lnuv_zetas",6,0,1,1,1298,0,0.,0.,0.,0,0,0,"lognormal_uncertain"}, {"zetas",14,0,1,1,1299,0,0.,0.,0.,0,"{lognormal uncertain zetas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Lognormal",0,"lognormal_uncertain"} }
static KeyWord kw_213 |
{ {"error_factors",14,0,1,1,1305,0,0.,0.,0.,0,"[CHOOSE variance spec.]{lognormal uncertain error factors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Lognormal",0,"lognormal_uncertain"}, {"lnuv_error_factors",6,0,1,1,1304,0,0.,0.,0.,0,0,0,"lognormal_uncertain"}, {"lnuv_std_deviations",6,0,1,1,1302,0,0.,0.,0.,0,0,0,"lognormal_uncertain"}, {"std_deviations",14,0,1,1,1303,0,0.,0.,0.,0,"@{lognormal uncertain standard deviations} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Lognormal",0,"lognormal_uncertain"} }
static KeyWord kw_214 |
{ {"descriptors",15,0,4,0,1311,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Lognormal",0,"lognormal_uncertain"}, {"lambdas",14,2,1,1,1297,kw_212,0.,0.,0.,0,"[CHOOSE characterization]{lognormal uncertain lambdas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Lognormal",0,"lognormal_uncertain"}, {"lnuv_descriptors",7,0,4,0,1310,0,0.,0.,0.,0,0,0,"lognormal_uncertain"}, {"lnuv_lambdas",6,2,1,1,1296,kw_212,0.,0.,0.,0,0,0,"lognormal_uncertain"}, {"lnuv_lower_bounds",6,0,2,0,1306,0,0.,0.,0.,0,0,0,"lognormal_uncertain"}, {"lnuv_means",6,4,1,1,1300,kw_213,0.,0.,0.,0,0,0,"lognormal_uncertain"}, {"lnuv_upper_bounds",6,0,3,0,1308,0,0.,0.,0.,0,0,0,"lognormal_uncertain"}, {"lower_bounds",14,0,2,0,1307,0,0.,0.,0.,0,"{Distribution lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Lognormal",0,"lognormal_uncertain"}, {"means",14,4,1,1,1301,kw_213,0.,0.,0.,0,"@{lognormal uncertain means} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Lognormal",0,"lognormal_uncertain"}, {"upper_bounds",14,0,3,0,1309,0,0.,0.,0.,0,"{Distribution upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Lognormal",0,"lognormal_uncertain"} }
static KeyWord kw_215 |
{ {"descriptors",15,0,3,0,1327,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Loguniform",0,"loguniform_uncertain"}, {"lower_bounds",14,0,1,1,1323,0,0.,0.,0.,0,"{Distribution lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Loguniform",0,"loguniform_uncertain"}, {"luuv_descriptors",7,0,3,0,1326,0,0.,0.,0.,0,0,0,"loguniform_uncertain"}, {"luuv_lower_bounds",6,0,1,1,1322,0,0.,0.,0.,0,0,0,"loguniform_uncertain"}, {"luuv_upper_bounds",6,0,2,2,1324,0,0.,0.,0.,0,0,0,"loguniform_uncertain"}, {"upper_bounds",14,0,2,2,1325,0,0.,0.,0.,0,"{Distribution upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Loguniform",0,"loguniform_uncertain"} }
static KeyWord kw_216 |
{ {"descriptors",15,0,3,0,1421,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Negative_Binomial",0,"negative_binomial_uncertain"}, {"num_trials",13,0,2,2,1419,0,0.,0.,0.,0,"{negative binomial uncertain success num_trials} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Negative_Binomial",0,"negative_binomial_uncertain"}, {"prob_per_trial",14,0,1,1,1417,0,0.,0.,0.,0,"{negative binomial uncertain success prob_per_trial} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Negative_Binomial",0,"negative_binomial_uncertain"} }
static KeyWord kw_217 |
{ {"descriptors",15,0,5,0,1293,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Normal",0,"normal_uncertain"}, {"lower_bounds",14,0,3,0,1289,0,0.,0.,0.,0,"{Distribution lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Normal",0,"normal_uncertain"}, {"means",14,0,1,1,1285,0,0.,0.,0.,0,"{normal uncertain means} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Normal",0,"normal_uncertain"}, {"nuv_descriptors",7,0,5,0,1292,0,0.,0.,0.,0,0,0,"normal_uncertain"}, {"nuv_lower_bounds",6,0,3,0,1288,0,0.,0.,0.,0,0,0,"normal_uncertain"}, {"nuv_means",6,0,1,1,1284,0,0.,0.,0.,0,0,0,"normal_uncertain"}, {"nuv_std_deviations",6,0,2,2,1286,0,0.,0.,0.,0,0,0,"normal_uncertain"}, {"nuv_upper_bounds",6,0,4,0,1290,0,0.,0.,0.,0,0,0,"normal_uncertain"}, {"std_deviations",14,0,2,2,1287,0,0.,0.,0.,0,"{normal uncertain standard deviations} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Normal",0,"normal_uncertain"}, {"upper_bounds",14,0,4,0,1291,0,0.,0.,0.,0,"{Distribution upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Normal",0,"normal_uncertain"} }
static KeyWord kw_218 |
{ {"descriptors",15,0,2,0,1405,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Poisson",0,"poisson_uncertain"}, {"lambdas",14,0,1,1,1403,0,0.,0.,0.,0,"{poisson uncertain lambdas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarDAUV_Poisson",0,"poisson_uncertain"} }
static KeyWord kw_219 |
{ {"descriptors",15,0,4,0,1337,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Triangular",0,"triangular_uncertain"}, {"lower_bounds",14,0,2,2,1333,0,0.,0.,0.,0,"{Distribution lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Triangular",0,"triangular_uncertain"}, {"modes",14,0,1,1,1331,0,0.,0.,0.,0,"{triangular uncertain modes} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Triangular",0,"triangular_uncertain"}, {"tuv_descriptors",7,0,4,0,1336,0,0.,0.,0.,0,0,0,"triangular_uncertain"}, {"tuv_lower_bounds",6,0,2,2,1332,0,0.,0.,0.,0,0,0,"triangular_uncertain"}, {"tuv_modes",6,0,1,1,1330,0,0.,0.,0.,0,0,0,"triangular_uncertain"}, {"tuv_upper_bounds",6,0,3,3,1334,0,0.,0.,0.,0,0,0,"triangular_uncertain"}, {"upper_bounds",14,0,3,3,1335,0,0.,0.,0.,0,"{Distribution upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Triangular",0,"triangular_uncertain"} }
static KeyWord kw_220 |
{ {"descriptors",15,0,3,0,1319,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Uniform",0,"uniform_uncertain"}, {"lower_bounds",14,0,1,1,1315,0,0.,0.,0.,0,"{Distribution lower bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Uniform",0,"uniform_uncertain"}, {"upper_bounds",14,0,2,2,1317,0,0.,0.,0.,0,"{Distribution upper bounds} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Uniform",0,"uniform_uncertain"}, {"uuv_descriptors",7,0,3,0,1318,0,0.,0.,0.,0,0,0,"uniform_uncertain"}, {"uuv_lower_bounds",6,0,1,1,1314,0,0.,0.,0.,0,0,0,"uniform_uncertain"}, {"uuv_upper_bounds",6,0,2,2,1316,0,0.,0.,0.,0,0,0,"uniform_uncertain"} }
static KeyWord kw_221 |
{ {"alphas",14,0,1,1,1383,0,0.,0.,0.,0,"{weibull uncertain alphas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Weibull",0,"weibull_uncertain"}, {"betas",14,0,2,2,1385,0,0.,0.,0.,0,"{weibull uncertain betas} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Weibull",0,"weibull_uncertain"}, {"descriptors",15,0,3,0,1387,0,0.,0.,0.,0,"{Descriptors} http://www.cs.sandia.gov/dakota/licensing/votd/html-ref/VarCommands.html#VarCAUV_Weibull",0,"weibull_uncertain"}, {"wuv_alphas",6,0,1,1,1382,0,0.,0.,0.,0,0,0,"weibull_uncertain"}, {"wuv_betas",6,0,2,2,1384,0,0.,0.,0.,0,0,0,"weibull_uncertain"}, {"wuv_descriptors",7,0,3,0,1386,0,0.,0.,0.,0,0,0,"weibull_uncertain"} }
static KeyWord kw_223 |
{ {"interface",0x308,10,5,5,1501,kw_9,0.,0.,0.,0,"{Interface} An interface specifies how function evaluations will be performed in order to map a set of parameters into a set of responses. http://www.cs.sandia.gov/DAKOTA/licensing/votd/html-ref/InterfCommands.html"}, {"method",0x308,75,2,2,59,kw_141,0.,0.,0.,0,"{Method} A method specifies the name and controls of an iterative procedure, e.g., a sensitivity analysis, uncertainty quantification, or optimization method. http://www.cs.sandia.gov/DAKOTA/licensing/votd/html-ref/MethodCommands.html"}, {"model",8,6,3,3,1063,kw_164,0.,0.,0.,0,"{Model} A model consists of a model type and maps specified variables through an interface to generate responses. http://www.cs.sandia.gov/DAKOTA/licensing/votd/html-ref/ModelCommands.html"}, {"responses",0x308,15,6,6,1595,kw_181,0.,0.,0.,0,"{Responses} A responses object specifies the data that can be returned to DAKOTA through the interface after the completion of a function evaluation. http://www.cs.sandia.gov/DAKOTA/licensing/votd/html-ref/RespCommands.html"}, {"strategy",0x108,10,1,1,1,kw_192,0.,0.,0.,0,"{Strategy} The strategy specifies the top level technique which will govern the management of iterators and models in the solution of the problem of interest. http://www.cs.sandia.gov/DAKOTA/licensing/votd/html-ref/StratCommands.html"}, {"variables",0x308,29,4,4,1235,kw_222,0.,0.,0.,0,"{Variables} A variables object specifies the parameter set to be iterated by a particular method. http://www.cs.sandia.gov/DAKOTA/licensing/votd/html-ref/VarCommands.html"} }
KeyWord kw_224[8] |
{ {"descriptors",15,0,4,0,0,0.,0.,0,N_vae(ceulbl,CEUVar_interval)}, {"interval_bounds",14,0,3,2,0,0.,0.,0,N_vam(vrl,Var_Info_Ivb)}, {"interval_probs",14,0,2,1,0,0.,0.,0,N_vam(vrl,Var_Info_Ivp)}, {"iuv_descriptors",7,0,4,0,0,0.,0.,-3,N_vae(ceulbl,CEUVar_interval)}, {"iuv_interval_bounds",6,0,3,2,0,0.,0.,-3,N_vam(vrl,Var_Info_Ivb)}, {"iuv_interval_probs",6,0,2,1,0,0.,0.,-3,N_vam(vrl,Var_Info_Ivp)}, {"iuv_num_intervals",5,0,1,0,0,0.,0.,1,N_vam(vil,Var_Info_nIv)}, {"num_intervals",13,0,1,0,0,0.,0.,0,N_vam(vil,Var_Info_nIv)} }
KeyWord kw_225[2] |
{ {"lnuv_zetas",6,0,1,1,0,0.,0.,1,N_vam(RealLb,lognormalUncZetas)}, {"zetas",14,0,1,1,0,0.,0.,0,N_vam(RealLb,lognormalUncZetas)} }
KeyWord kw_226[4] |
{ {"error_factors",14,0,1,1,0,0.,0.,0,N_vam(RealLb,lognormalUncErrFacts)}, {"lnuv_error_factors",6,0,1,1,0,0.,0.,-1,N_vam(RealLb,lognormalUncErrFacts)}, {"lnuv_std_deviations",6,0,1,1,0,0.,0.,1,N_vam(RealLb,lognormalUncStdDevs)}, {"std_deviations",14,0,1,1,0,0.,0.,0,N_vam(RealLb,lognormalUncStdDevs)} }
KeyWord kw_227[10] |
{ {"descriptors",15,0,4,0,0,0.,0.,0,N_vae(caulbl,CAUVar_lognormal)}, {"lambdas",14,2,1,1,kw_225,0.,0.,0,N_vam(RealLd,lognormalUncLambdas)}, {"lnuv_descriptors",7,0,4,0,0,0.,0.,-2,N_vae(caulbl,CAUVar_lognormal)}, {"lnuv_lambdas",6,2,1,1,kw_225,0.,0.,-2,N_vam(RealLd,lognormalUncLambdas)}, {"lnuv_lower_bounds",6,0,2,0,0,0.,0.,3,N_vam(RealLb,lognormalUncLowerBnds)}, {"lnuv_means",6,4,1,1,kw_226,0.,0.,3,N_vam(RealLb,lognormalUncMeans)}, {"lnuv_upper_bounds",6,0,3,0,0,0.,0.,3,N_vam(RealUb,lognormalUncUpperBnds)}, {"lower_bounds",14,0,2,0,0,0.,0.,0,N_vam(RealLb,lognormalUncLowerBnds)}, {"means",14,4,1,1,kw_226,0.,0.,0,N_vam(RealLb,lognormalUncMeans)}, {"upper_bounds",14,0,3,0,0,0.,0.,0,N_vam(RealUb,lognormalUncUpperBnds)} }
KeyWord kw_228[6] |
{ {"descriptors",15,0,3,0,0,0.,0.,0,N_vae(caulbl,CAUVar_loguniform)}, {"lower_bounds",14,0,1,1,0,0.,0.,0,N_vam(RealLb,loguniformUncLowerBnds)}, {"luuv_descriptors",7,0,3,0,0,0.,0.,-2,N_vae(caulbl,CAUVar_loguniform)}, {"luuv_lower_bounds",6,0,1,1,0,0.,0.,-2,N_vam(RealLb,loguniformUncLowerBnds)}, {"luuv_upper_bounds",6,0,2,2,0,0.,0.,1,N_vam(RealUb,loguniformUncUpperBnds)}, {"upper_bounds",14,0,2,2,0,0.,0.,0,N_vam(RealUb,loguniformUncUpperBnds)} }
KeyWord kw_229[3] |
{ {"descriptors",15,0,3,0,0,0.,0.,0,N_vae(dailbl,DAUIVar_negative_binomial)}, {"num_trials",13,0,2,2,0,0.,0.,0,N_vam(intDL,negBinomialUncNumTrials)}, {"prob_per_trial",14,0,1,1,0,0.,0.,0,N_vam(RealLd,negBinomialUncProbPerTrial)} }
KeyWord kw_230[10] |
{ {"descriptors",15,0,5,0,0,0.,0.,0,N_vae(caulbl,CAUVar_normal)}, {"lower_bounds",14,0,3,0,0,0.,0.,0,N_vam(RealLd,normalUncLowerBnds)}, {"means",14,0,1,1,0,0.,0.,0,N_vam(RealLd,normalUncMeans)}, {"nuv_descriptors",7,0,5,0,0,0.,0.,-3,N_vae(caulbl,CAUVar_normal)}, {"nuv_lower_bounds",6,0,3,0,0,0.,0.,-3,N_vam(RealLd,normalUncLowerBnds)}, {"nuv_means",6,0,1,1,0,0.,0.,-3,N_vam(RealLd,normalUncMeans)}, {"nuv_std_deviations",6,0,2,2,0,0.,0.,2,N_vam(RealLb,normalUncStdDevs)}, {"nuv_upper_bounds",6,0,4,0,0,0.,0.,2,N_vam(RealLd,normalUncUpperBnds)}, {"std_deviations",14,0,2,2,0,0.,0.,0,N_vam(RealLb,normalUncStdDevs)}, {"upper_bounds",14,0,4,0,0,0.,0.,0,N_vam(RealLd,normalUncUpperBnds)} }
KeyWord kw_231[2] |
{ {"descriptors",15,0,2,0,0,0.,0.,0,N_vae(dailbl,DAUIVar_poisson)}, {"lambdas",14,0,1,1,0,0.,0.,0,N_vam(RealLd,poissonUncLambdas)} }
KeyWord kw_232[8] |
{ {"descriptors",15,0,4,0,0,0.,0.,0,N_vae(caulbl,CAUVar_triangular)}, {"lower_bounds",14,0,2,2,0,0.,0.,0,N_vam(RealLb,triangularUncLowerBnds)}, {"modes",14,0,1,1,0,0.,0.,0,N_vam(RealLd,triangularUncModes)}, {"tuv_descriptors",7,0,4,0,0,0.,0.,-3,N_vae(caulbl,CAUVar_triangular)}, {"tuv_lower_bounds",6,0,2,2,0,0.,0.,-3,N_vam(RealLb,triangularUncLowerBnds)}, {"tuv_modes",6,0,1,1,0,0.,0.,-3,N_vam(RealLd,triangularUncModes)}, {"tuv_upper_bounds",6,0,3,3,0,0.,0.,1,N_vam(RealUb,triangularUncUpperBnds)}, {"upper_bounds",14,0,3,3,0,0.,0.,0,N_vam(RealUb,triangularUncUpperBnds)} }
KeyWord kw_233[6] |
{ {"descriptors",15,0,3,0,0,0.,0.,0,N_vae(caulbl,CAUVar_uniform)}, {"lower_bounds",14,0,1,1,0,0.,0.,0,N_vam(RealLb,uniformUncLowerBnds)}, {"upper_bounds",14,0,2,2,0,0.,0.,0,N_vam(RealUb,uniformUncUpperBnds)}, {"uuv_descriptors",7,0,3,0,0,0.,0.,-3,N_vae(caulbl,CAUVar_uniform)}, {"uuv_lower_bounds",6,0,1,1,0,0.,0.,-3,N_vam(RealLb,uniformUncLowerBnds)}, {"uuv_upper_bounds",6,0,2,2,0,0.,0.,-3,N_vam(RealUb,uniformUncUpperBnds)} }
KeyWord kw_234[6] |
{ {"alphas",14,0,1,1,0,0.,0.,0,N_vam(RealLb,weibullUncAlphas)}, {"betas",14,0,2,2,0,0.,0.,0,N_vam(RealLb,weibullUncBetas)}, {"descriptors",15,0,3,0,0,0.,0.,0,N_vae(caulbl,CAUVar_weibull)}, {"wuv_alphas",6,0,1,1,0,0.,0.,-3,N_vam(RealLb,weibullUncAlphas)}, {"wuv_betas",6,0,2,2,0,0.,0.,-3,N_vam(RealLb,weibullUncBetas)}, {"wuv_descriptors",7,0,3,0,0,0.,0.,-3,N_vae(caulbl,CAUVar_weibull)} }
KeyWord kw_236[6] |
{ {"interface",0x308,10,5,5,kw_9,0.,0.,0,N_ifm3(start,0,stop)}, {"method",0x308,75,2,2,kw_153,0.,0.,0,N_mdm3(start,0,stop)}, {"model",8,6,3,3,kw_177,0.,0.,0,N_mom3(start,0,stop)}, {"responses",0x308,15,6,6,kw_194,0.,0.,0,N_rem3(start,0,stop)}, {"strategy",0x108,10,1,1,kw_205,0.,0.,0,NIDRProblemDescDB::strategy_start}, {"variables",0x308,29,4,4,kw_235,0.,0.,0,N_vam3(start,0,stop)} }
Var_uinfo CAUVLbl[CAUVar_Nkinds] [static] |
{ UncInfo(nuv_, Normal), UncInfo(lnuv_, Lognormal), UncInfo(uuv_, Uniform), UncInfo(luuv_, Loguniform), UncInfo(tuv_, Triangular), UncInfo(euv_, Exponential), UncInfo(beuv_, Beta), UncInfo(gauv_, Gamma), UncInfo(guuv_, Gumbel), UncInfo(fuv_, Frechet), UncInfo(wuv_, Weibull), UncInfo(hbuv_, HistogramBin) }
Var_uinfo DAUIVLbl[DAUIVar_Nkinds] [static] |
{ UncInfo(puv_, Poisson), UncInfo(biuv_, Binomial), UncInfo(nbuv_, NegBinomial), UncInfo(geuv_, Geometric), UncInfo(hguv_, HyperGeom) }
Var_uinfo DAURVLbl[DAURVar_Nkinds] [static] |
{ UncInfo(hpuv_, HistogramPt) }
Var_uinfo CEUVLbl[CEUVar_Nkinds] [static] |
{ UncInfo(iuv_, Interval) }
Var_uinfo DiscSetLbl[DiscSetVar_Nkinds] [static] |
{ DiscSetInfo(ddsiv_, DesSetInt), DiscSetInfo(ddsrv_, DesSetReal), DiscSetInfo(dssiv_, StateSetInt), DiscSetInfo(dssrv_, StateSetReal) }
VarLabelChk Vlch[] [static] |
{ { AVI numContinuousDesVars, AVI continuousDesignLabels, "cdv_", "cdv_descriptors" }, { AVI numDiscreteDesRangeVars, AVI discreteDesignRangeLabels, "ddriv_", "ddriv_descriptors" }, { AVI numDiscreteDesSetIntVars, AVI discreteDesignSetIntLabels, "ddsiv_", "ddsiv_descriptors" }, { AVI numDiscreteDesSetRealVars, AVI discreteDesignSetRealLabels, "ddsrv_", "ddsrv_descriptors" }, { AVI numContinuousStateVars, AVI continuousStateLabels, "csv_", "csv_descriptors" }, { AVI numDiscreteStateRangeVars, AVI discreteStateRangeLabels, "dsriv_", "dsriv_descriptors" }, { AVI numDiscreteStateSetIntVars, AVI discreteStateSetIntLabels, "dssiv_", "dssiv_descriptors" }, { AVI numDiscreteStateSetRealVars, AVI discreteStateSetRealLabels, "dssrv_", "dssrv_descriptors" }, { AVI numContinuousDesVars, AVI continuousDesignScaleTypes, 0, "cdv_scale_types" } }
VLstuff VLS[N_VLS] [static] |
{ {CAUVar_Nkinds, 1, AVI CAUv, CAUVLbl, DVR continuousAleatoryUncLabels, DVR continuousAleatoryUncLowerBnds, DVR continuousAleatoryUncUpperBnds, DVR continuousAleatoryUncVars}, {CEUVar_Nkinds, 1, AVI CEUv, CEUVLbl, DVR continuousEpistemicUncLabels, DVR continuousEpistemicUncLowerBnds, DVR continuousEpistemicUncUpperBnds, DVR continuousEpistemicUncVars}, {DAUIVar_Nkinds, 0, AVI DAUIv, DAUIVLbl, DVR discreteIntAleatoryUncLabels, RDVR discreteIntAleatoryUncLowerBnds, RDVR discreteIntAleatoryUncUpperBnds, RDVR discreteIntAleatoryUncVars}, {DAURVar_Nkinds, 1, AVI DAURv, DAURVLbl, DVR discreteRealAleatoryUncLabels, DVR discreteRealAleatoryUncLowerBnds, DVR discreteRealAleatoryUncUpperBnds, DVR discreteRealAleatoryUncVars}}
Var_bgen var_mp_bgen[] [static] |
{ Vchu0(gamma_uncertain,numGammaUncVars,Gamma), Vchu0(gumbel_uncertain,numGumbelUncVars,Gumbel), Vchu0(frechet_uncertain,numFrechetUncVars,Frechet), Vchu0(weibull_uncertain,numWeibullUncVars,Weibull), Vchu0(histogram_bin_uncertain,numHistogramBinUncVars,HistogramBin) }
Var_bgen var_mp_bgen_audr[] |
{ Vchu0(histogram_point_uncertain,numHistogramPtUncVars,HistogramPt) }
Var_bgen var_mp_bgen_audi[] |
{ Vchu0(poisson_uncertain,numPoissonUncVars,Poisson), Vchu0(binomial_uncertain,numBinomialUncVars,Binomial), Vchu0(negative_binomial_uncertain,numNegBinomialUncVars,NegBinomial), Vchu0(geometric_uncertain,numGeometricUncVars,Geometric), Vchu0(hypergeometric_uncertain,numHyperGeomUncVars,HyperGeom) }
Var_bgen var_mp_bgen_eu[] |
{ Vchu0(interval_uncertain,numIntervalUncVars,Interval) }
Var_bgen var_mp_bgen_dis[] |
{ Vchu0(discrete_design_set_integer,numDiscreteDesSetIntVars,DDSI), Vchu0(discrete_design_set_real,numDiscreteDesSetRealVars,DDSR), Vchu0(discrete_state_set_integer,numDiscreteStateSetIntVars,DSSI), Vchu0(discrete_state_set_real,numDiscreteStateSetRealVars,DSSR) }
VarBgen Bgen[] [static] |
{ BgenInit(var_mp_bgen_audr), BgenInit(var_mp_bgen_audi), BgenInit(var_mp_bgen_eu)}
Var_bchk var_mp_bndchk[] [static] |
{ Vchv(continuous_design,numContinuousDesVars,continuousDesign), Vchu1(normal_uncertain,numNormalUncVars,normalUnc), Vchu1(lognormal_uncertain,numLognormalUncVars,lognormalUnc), Vchu(uniform_uncertain,numUniformUncVars,uniformUnc), Vchu(loguniform_uncertain,numLoguniformUncVars,loguniformUnc), Vchu(triangular_uncertain,numTriangularUncVars,triangularUnc), Vchu0(exponential_uncertain,numExponentialUncVars,Exponential), Vchu(beta_uncertain,numBetaUncVars,betaUnc), Vchv(continuous_state,numContinuousStateVars,continuousState) }
Var_ibchk var_mp_ibndchk[] [static] |
{ Vchi(discrete_design_range,numDiscreteDesRangeVars,discreteDesignRange), Vchi(discrete_state_range,numDiscreteStateRangeVars,discreteStateRange) }