CGO

From TomWiki
Revision as of 05:13, 22 September 2011 by Elias (talk | contribs) (Created page with "==Introduction== ===Overview=== Welcome to the TOMLAB /CGO User's Guide. TOMLAB /CGO includes the solvers, ''rbfSolve'', ''ego ''and ''arbfMIP''. The solvers are specificall...")
(diff) ← Older revision | Latest revision (diff) | Newer revision → (diff)
Jump to navigationJump to search

Introduction

Overview

Welcome to the TOMLAB /CGO User's Guide. TOMLAB /CGO includes the solvers, rbfSolve, ego and arbfMIP. The solvers are specifically designed to solve costly (expensive) global optimization problems with up to roughly 30 decision variables. The costly component is only the objective function, i.e. if the constraints are costly as well they need to be integrated in the objective.

The overall solution approach followed by TOMLAB /CGO is based on the seamless combination of the global and local search strategies. The package requires the presence of a global solver and a local solver.

Contents of this manual

  • Section 1 provides a basic overview of the TOMLAB /CGO solver package.
  • Section 2 provides an overview of the solver interface.
  • Section 3 describes how to set CGO solver options from Matlab.
  • Section 4 provides information regarding (non-costly) TOMLAB /CGO test examples.
  • Section 5 gives detailed information about the interface routines rbfSolve, ego and arbfMIP.

More information

Please visit the following links for more information and see the references at the end of this manual.

Prerequisites

In this concise manual we assume that the user is familiar with global optimization and nonlinear programming, setting up problems in TOMLAB (in particular global constrained nonlinear (glc) problems) and with the Matlab language in general.

Using the Matlab Interface

The CGO solver package is accessed via the tomRun driver routine, which calls the rbfSolve, ego or arbfMIP routines.

<figtable id="costGlobSolv">

The Costly global solver routines.
Function Description
rbfSolve Costly global solver routine called by the TOMLAB driver routine tomRun. This routine will also call local and global subsolvers.
ego Costly global solver routine called by the TOMLAB driver routine tomRun. This routine will also call local and global subsolvers.
arbfMIP Costly global solver routine called by the TOMLAB driver routine tomRun. This routine will also call local and global subsolvers.

Setting CGO Options

All control parameters can be set directly from Matlab.

The parameters can be set as subfields in the Prob.CGO, Prob.optParam and Prob.GO structures. The following example shows how to set a limit on the maximum number of iterations when using a global subsolver to solve some sub problem and the global search idea (surface search strategy) used by rbfSolve. The major thing is most often to set the limit MaxFunc, defining how many costly function evaluations the CGO solver is allowed to use.

Prob = glcAssign(...)		%   Setup problem, see help glcAssign for  more information

Prob.GO.MaxIter  = 50; 		%   Setting the maximum number iterations. 
Prob.CGO.idea = 1; 		%   Idea set to first  option. 
Prob.optParam.MaxFunc = 90;  	%   Maximal number of  costly function evaluations

A complete description of the available CGO parameters can be found in Section 5.

TOMLAB /CGO Test Examples

There are several test examples included in the general TOMLAB distribution. The examples are located in the testprob folder in TOMLAB. lgo1_prob contains one dimensional test problems while lgo2_prob includes two- and higher-dimensional. Several problems are also available in glb_prob, glc_prob, glcIP_prob and minlp_prob.

To test the solution of these problem sets with CGO, the following type of code can be used:

Prob = probInit('lgo1_prob', 1); 

Result  = tomRun('rbfSolve', Prob,  1);

TOMLAB /CGO Solver Reference

A detailed description of the TOMLAB /CGO solvers is given below. Also see the M-file help for rbfSolve.m, ego.m and arbfMIP.m.

rbfSolve

Purpose

Solve general constrained mixed-integer global black-box optimization problems with costly objective functions.

The optimization problem is of the following form

Failed to parse (unknown function "\multicolumn"): {\displaystyle \begin{array}{cccccc} \min\limits_{x} & f(x) & & & & \\ s/t & x_{L} & \leq & x & \leq & x_{U} \\ & b_{L} & \leq & Ax & \leq & b_{U} \\ & c_{L} & \leq & c(x) & \leq & c_{U} \\ &\multicolumn{5}{c}{ ~x_{j} \in \MATHSET{N}\ ~~\forall j \in \MATHSET{I}}, \\ \end{array} }

where Failed to parse (unknown function "\MATHSET"): {\displaystyle f(x) \in \MATHSET{R}} ; Failed to parse (unknown function "\MATHSET"): {\displaystyle x_L,~x,~x_U \in \MATHSET{R}^d} ; the linear constraints are defined by Failed to parse (unknown function "\MATHSET"): {\displaystyle A \in \MATHSET{R}^{m_1 \times d}} , Failed to parse (unknown function "\MATHSET"): {\displaystyle b_L,~b_U \in \MATHSET{R}^{m_1}} ; and the nonlinear constraints are defined by Failed to parse (unknown function "\MATHSET"): {\displaystyle c_L,~c(x),~c_U \in~ \MATHSET{R}^{m_2}} . The variables are restricted to be integers, where Failed to parse (unknown function "\MATHSET"): {\displaystyle \MATHSET{I}} is an index subset of \{1,\ldots,\}, possibly empty. It is assumed that the function is continuous with respect to all variables, even if there is a demand that some variables only take integer values. Otherwise it would not make sense to do the surrogate modeling of used by all CGO solvers.

f (x) is assumed to be a costly function while c(x) is assumed to be cheaply computed. Any costly constraints can be treated by adding penalty terms to the objective function in the following way:

Failed to parse (syntax error): {\displaystyle \min\limits_x & p(x)=f(x)+\sum\limits_{j} w_j\max\left(0,~c^j(x)-c_U^j, ~~c_L^j-c^j(x) \right), \end{array} }

where weighting parameters wj have been added. The user then returns p(x) instead of f (x) to the CGO solver.

Calling Syntax

Result = rbfSolve(Prob,varargin) Result = tomRun('rbfSolve', Prob);

Description of Inputs

Problem description structure. The following fields are used:

eps f Relative accuracy for function value, f T ol == eps f . Stop if \|f - f Goal\| =\|f Goal\| * f T ol , if f Goal = 0. Stop if \|f - f Goal\| = f T ol , if f Goal = 0. See the output field maxTri. bTol Linear constraint tolerance.
Field Description
Name Name of the problem. Used for security when doing warm starts.
FUNCS.f Name of function to compute the objective function.
FUNCS.c Name of function to compute the nonlinear constraint vector.
x_L Lower bounds on the variables. Must be finite.
x_U Upper bounds on the variables. Must be finite.
b_U Upper bounds for the linear constraints.
b_L Lower bounds for the linear constraints.
A Linear constraint matrix.
c_L Lower bounds for the nonlinear constraints.
c_U Upper bounds for the nonlinear constraints.
WarmStart Set true (non-zero) to load data from previous run from cgoSave.mat and resume optimization from where the last run ended. If Prob.CGO.WarmStartInfo has been defined through a call to WarmDefGLOBAL, this field is used instead of the cgoSave.mat file. All CGO solvers uses the same mat-file and structure field and can read the output of one another.
MaxCPU Maximal CPU Time (in seconds) to be used.
user User field used to send information to low-level functions.
PriLevOpt Print Level. 0 = silent. 1 = Summary 2 = Printing each iteration. 3 = Info about local / global solution. 4 = Progress in x.
PriLevSub Print Level in subproblem solvers, see help in snSolve and gnSolve.
f_Low Lower bound on the optimal function value. If defined, used to restrict the target values into interval \[f Low,min(surface)\].
optParam Structure with optimization parameters. The following fields are used:
MaxFunc Maximal number of costly function evaluations, default 300 for rbfSolve and arbfMIP, and default 200 for ego. MaxFunc must be = 5000. If WarmStart = 1 and MaxFunc = nFunc (Number of f(x) used) then set MaxFunc := MaxFunc + nFunc.
IterPrint Print one information line each iteration, and the new x tried. Default IterPrint

= 1. fMinI means the best f(x) is infeasible. fMinF means the best f(x) is feasible (also integer feasible).

fGoal Goal for function value, not used if inf or empty.
cTol Nonlinear constraint tolerance.
MaxIter Maximal number of iterations used in the local optimization on the re- sponse surface in each step. Default 1000, except for pure IP problems, then max(GO.MaxFunc, MaxIter);.
CGO Structure (Prob.CGO) with parameters concerning global optimization options.
Percent Type of strategy to get the initial sampled values:
Percent Experimental Design ExD
Corner strategies
900 All Corners 1
997 xL + xU + adjacent corners 2
998 xU + adjacent corners 3
999 xL + adjacent corners 4

Deterministic Strategies||

0 User given initial points 5
94 DIRECT solver glbFast 6
95 DIRECT solver glcFast 6
96 DIRECT solver glbSolve 6
97 DIRECT solver glcSolve 6
98 DIRECT solver glbDirect 6
99 DIRECT solver glcDirect 6

Latin Based Sampling||

1 Maximin LHD 1-norm 7
2 Maximin LHD 2-norm 8
3 Maximin LHD Inf-norm 9
4 Minimal Audze-Eglais 10
5 Minimax LHD (only 2 dim) 11
6 Latin Hypercube 12
7 Orthogonal Samling 13

Random Strategies (pp in %)||

1pp Circle surrounding 14
2pp Ellipsoid surrounding 15
3pp Rectangle surrounding 16

Negative values of Percent result in constrained versions of the experimental design methods 7-16. It means that all points sampled are feasible with respect to all given constraints.

For ExD 5,6-12,14-16 user defined points are used.

nSample Number of sample points to be used in initial experimental design. nSample is used differently dependent on the value of Percent:
(n)Sample:
ExD < 0 = 0 > 0 []
1 2d
6 |n| iterations
7-11 d+1 d+1 max(d + 1,n) (d + 1)(d + 2) / 2
12 LATIN(k)
13 |n|
14-16 d + 1

where LATIN = [21 21 33 41 51 65 65] and k = |nSample|. Otherwise nSample as input does not matter.

Description of the experimental designs:

ExD 1,All Corners. Initial points is the corner points of the box given by Prob.x L and Prob.x U. Generates 2d points, which results in too many points when the dimension is high.

ExD 2, Lower and Upper Corner point + adjacent points. Initial points are 2 * d + 2 corners: the lower left corner xL and its d adjacent corners xL + (xU (i) - xL (i)) * ei , i = 1, ..., d and the upper right corner xU and its d adjacent corners xU - (xU (i) - xL (i)) * ei , i = 1, ..., d

ExD 3. Initial points are the upper right corner xU and its d adjacent corners xU - (xU (i) - xL (i)) * ei , i = 1, ..., d

ExD 4. Initial points are the lower left corner xL and its d adjacent corners xL + (xU (i) - xL (i)) * ei , i = 1, ..., d

ExD 5. User given initial points, given as a matrix in CGO.X. Each column is one sampled point. If d = length(Prob.x L), then size(X,1) = d, size(X,2) = d + 1. CGO.F should be defined as empty, or contain a vector of corresponding f (x) values. Any CGO.F value set as NaN will be computed by solver routine.

ExD 6. Use determinstic global optimization methods to find the initial design. Current methods available (all DIRECT methods), dependent on the value of Percent:

99 = glcDirect, 98 = glbDirect, 97 = glcSolve, 96 = glbSolve, 95 = glcFast, 94 = glbFast.

ExD 7-11. Optimal Latin Hypercube Designs (LHD) with respect to different norms. The following norms and designs are available, dependent on the value of Percent:

1 = Maximin 1-Norm, 2 = Maximin 2-Norm, 3 = Maximin Inf-Norm, 4 = Audze-Eglais Norm, 5 = Minimax 2-Norm.

All designs taken from: http://www.spacefillingdesigns.nl/

Constrained versions will try bigger and bigger designs up to M = max(10 * d, nTrial) different designs, stopping when it has found nSample feasible points.

ExD 12. Latin hypercube space-filling design. For nSample < 0, k = |nSample| should in principle be the problem dimension. The number of points sampled is: k : 2 3 4 5 6 > 6 Points : 21 33 41 51 65 65

The call made is: X = daceInit(abs(nSample),Prob.x_L,Prob.x_U); Set nSample = [] to get (d+1)*(d+2)/2 sampled points:

d : 1 2 3 4 5 6 7 8 9 10 Points : 3 6 10 15 21 28 36 45 55 66

This is a more efficient number of points to use.

If CGO.X is nonempty, these points are verified as in ExD 5, and treated as al- ready sampled points. Then nSample additional points are sampled, restricted to be close to the given points.

Constrained version of Latin hypercube only keep points that fulfill the linear and nonlinear constraints. The algorithm will try up to M = max(10 * d, nTrial) points, stopping when it has found nSample feasible points (d + 1 points if nSample < 0).

ExD 13. Orthogonal Sampling, LH with subspace density demands.

ExD 14-16. Random strategies, the |Percent| value gives the percentage size of an ellipsoid, circle or rectangle around the so far sampled points that new points are not allowed in. Range 1%-50%. Recommended values 10% - 20%. If CGO.X is nonempty, these points are verified as in ExD 5, and treated as al- ready sampled points. Then nSample additional points are sampled, restricted to be close to the given points.

X,F,CX The fields X,F,CX are used to define user given points. ExD = 5 (Percent = 0) needs this information. If ExD == 6-12,14-16 these points are included into the design.
X A matrix of initial x values. One column for every x value. If ExD == 5, size(X,2) = dim(x)+1 needed.
F A vector of initial f (x) values. If any element is set to NaN it will be computed.
CX Optionally a matrix of nonlinear constraint c(x) values. If nonempty, then size(CX,2) == size(X,2). If any element is set as NaN, the vector c(x) = CX(:,i) will be recomputed.
RandState If = 0, rand(!state!, RandState) is set to initialize the pseudo-random genera- tor. If < 0, rand(!state!, 100 * clock) is set to give a new set of random values each run. If isnan(RandState), the random state is not initialized. RandState will influence if a stochastic initial experimental design is applied, see input Per- cent and nSample. RandState will also influence if using the multiMin solver, but the random state seed is not reset in multiMin. The state of the random generator is saved in the warm start output rngState, and the random genera- tor is reinitialized with this state if warm start is used. Default RandState = 0.
AddMP If = 1, add the midpoint as extra point in the corner strategies. Default 1 for any corner strategy, i.e. Percent is 900, 997, 998 or 999.
nTrial For experimental design CLH, the method generates M = max(10 * d, nT rial) trial points, and evaluate them until nSample feasible points are found. In the random designs, nTrial is the maximum number of trial points randomly generated for each new point to sample.
CLHMethod Different search strategies for finding feasible LH points. First of all, the least infeasible point is added. Then the linear feasible points are considered. If more points are needed still, the nonlinear infeasible points are added.

1 - Take the sampled infeasible points in order.

2 - Take a random sample of the infeasible points.

3 - Use points with lowest constraint error (cErr).

SCALE 0 - Original search space (default if any integer values).

1 - Transform search space to unit cube (default if no integers).

REPLACE 0 - No replacement, default for constrained problems.

1 - Large function values are replaced by the median.

> 1 - Large values Z are replaced by new values. The replacement is defined as Z := FMAX + log10(Z - FMAX + 1), where FMAX = 10REPLACE , if min(F ) < 0 and FMAX = 10(ceil(log10(min(F )))+REPLACE), if min(F ) = 0. A new replacement is computed in every iteration, because min(F ) may change. Default REPLACE = 5, if no linear or nonlinear constraints.

LOCAL 0 - No local searches after global search. If RBF surface is inaccurate, might be an advantage.

1 - Local search from best points after global search. If equal best function values, up to 20 local searches are done.

SMOOTH 1 - The problem is smooth enough for local search using numerical gradient estimation methods (default).

0 - The problem is nonsmooth or noisy, and local search methods using numer- ical gradient estimation are likely to produce garbage search directions.

globalSolver Global optimization solver used for subproblem optimization. Default glcCluster (SMOOTH=1) or glcDirect (SMOOTH=0). If the global- Solver is glcCluster, the fields Prob.GO.maxFunc1, Prob.GO.maxFunc2, Prob.GO.maxFunc3, Prob.GO.localSolver, Prob.GO.DIRECT and other fields set in Prob.GO are used. See the help for these parameters in glcCluster.
localSolver Local optimization solver used for subproblem optimization. If not defined, the TOMLAB default constrained NLP solver is used.

- Special RBF algorithm parameters in Prob.CGO -

rbfType Type of radial basis function: 1 - thin plate spline; 2 - Cubic Spline (default); 3 - Multiquadric; 4 - Inverse multiquadric; 5 - Gaussian; 6 - Linear.
idea Type of search strategy on the response surface.

idea = 1 - cycle of N+1 points in target value fnStar.

if fStarRule =3, then N=1 default, otherwise N=4 default.

By default idea =1, fStarRule =1, i.e. N =4. To change N, see below.

idea = 2 - cycle of 4 points (N+1, N=3 always) in alpha. alpha is a bound on an algorithmic constraint that implicitly sets a target value fStar.

N Cycle length in idea 1 (default N=1 for fStarRule 3, otherwise default N=4) or idea 2 (always N=3).
infStep If =1, add search step with target value -8 first in cycle. Default 0. Always

=1 for the case idea =1, fStarRule =3.

fStarRule Global-Local search strategy in idea 1, where N is the cycle length. Define minsn as the global minimum on the RBF surface. The following strategies for setting the target value fStar is defined: 1: f Star = minsn - ((N - (n - nI nit))/N )2 * ?n (Default), 2: f Star = minsn - (N - (n - nI nit))/N * ?n .

Strategy 1 and 2 depends on ? n estimate (see DeltaRule). If infStep =1, add

-8-step first in cycle. 3: fStar = -8-step, minsn -k *0.1*\|minsn \|k = N, ..., 0.

These strategies had the following names in Gutmanns thesis: III, II, I.

DeltaRule 1 = Skip large f(x) when computing f(x) interval ?. 0 = Use all points. Default 1.
AddSurfMin Add up to AddSurfMin interior local minima on RBF surface as search points, based on estimated Lipschitz constants. AddSurfMin=0 implies no additional minimum added (Default). This option is only possible if globalSolver = multiMin. Test for additional minimum is done in the local step (modN == N) If these additional local minima are used, in the printout modN = -2, -3, -4, ... are the iteration steps with these search points.
TargetMin Which minimum, if several minima found, to select in the target value problem:

=0 Use global minimum.

=1 Use best interior local minima, if none use global minimum.

=2 Use best interior local minima, if none use RBF interior minimum.

=3 Use best minimum with lowest number of coefficients on bounds. Default is TargetMin = 3.

eps_sn Relative tolerance used to test if the minimum of the RBF surface, minsn , is sufficiently lower than the best point (fM in ) found (default is 10-7 ).
MaxCycle Max number of cycles without progress before stopping, default 10.
GO Structure Prob.GO (Default values are set for all fields).

The following fields are used:

MaxFunc Maximal number of function evaluations in each global search.
MaxIter Maximal number of iterations in each global search.
DIRECT DIRECT solver used in glcCluster, either glcSolve or glcDirect(default).
maxFunc1 glcCluster parameter, maximum number of function evaluations in the first call. Only used if globalSolver is glcCluster, see help globalSolver.
maxFunc2 glcCluster parameter, maximum number of function evaluations in the second call. Only used if globalSolver is glcCluster, see help globalSolver.
maxFunc3 glcCluster parameter, maximum sum of function evaluations in repeated first calls to DIRECT routine when trying to get feasible. Only used if globalSolver is glcCluster, see help globalSolver.
localSolver The local solver used by glcCluster. If not defined, then Prob.CGO.localSolver is used
MIP Structure in Prob, Prob.MIP.

Defines integer optimization parameters. Fields used:

IntVars If empty, all variables are assumed non-integer.

If islogical(IntVars) (=all elements are 0/1), then 1 = integer variable, 0 = continuous variable. If any element > 1, IntVars is the indices for integer variables.

varargin Other parameters directly sent to low level routines.

Description of Outputs

Structure with result from optimization. The following fields are changed:

Iter Number of iterations. FuncEv Number of function evaluations. ExitText Text string with information about the run. ExitFlag Always 0. CGO Subfield WarmStartInfo saves warm start information, the same information as in cgoSave.mat, see below. Inform Information parameter. 0 = Normal termination. 1 = Function value f(x) is less than fGoal. 2 = Error in function value f (x), \|f - f Goal\| = f T ol, f Goal = 0. 3 = Relative Error in function value f (x) is less than fTol, i.e. \|f -f Goal\|/\|f Goal\| = f T ol. 4 = No new point sampled for MaxCycle iteration steps. 5 = All sample points same as the best point for MaxCycle last iterations. 6 = All sample points same as previous point for MaxCycle last iterations. 7 = All feasible integers tried. 8 = No progress for M axC ycle * (N + 1) + 1 function evaluations (> M axC ycle cycles, input CGO.MaxCycle). 9 = Max CPU Time reached. cgoSave.mat To make a warm start possible, all CGO solvers saves information in the file cgoSave.mat. The file is created independent of the solver, which enables the user to call any CGO solver using the warm start information. cgoSave.mat is a MATLAB mat-file saved to the current directory. If the parameter SAVE is 1, the CGO solver saves the mat file every iteration, which enables the user to break the run and restart using warm start from the current state. SAVE = 1 is currently always set by the CGO solvers. If the cgoSave.mat file fails to open for writing, the information is also available in the output field Result.CGO.WarmStartInfo, if the run was concluded without interruption. Through a call to WarmDefGLOBAL, the Prob structure can be setup for warm start. In this case, the CGO solver will not load the data from cgoSave.mat. The file contains the following variables:
Field Description
x_k Matrix with the best points as columns.
f_k The best function value found so far.
Name Problem name. Checked against the Prob.Name field if doing a warmstart.
O Matrix with sampled points (in original space).
X Matrix with sampled points (in unit space if SCALE==1)
F Vector with function values (penalty added for costly Cc(x))
F_m Vector with function values (replaced).
F00 Vector of pure function values, before penalties. Cc MMatrix with costly constraint values, C c(x). nInit Number of initial points.
Fpen Vector with function values + additional penalty if infeasible using the linear constraints and noncostly nonlinear c(x).
fMinIdx Index of the best point found.
rngState Current state of the random number generator used.

Description

rbfSolve implements the Radial Basis Function (RBF) algorithm presented in \[2\] and based on the work by Gutmann. The RBF method is enhanced to handle linear equality and inequality constraints, and nonlinear equality and inequality constraints, as well as mixed-integer problems.

A response surface based on radial basis functions is fitted to a collection of sampled points. The algorithm then balances between minimizing the fitted function and adding new points to the set.

M-files Used

daceInit.m, iniSolve.m, endSolve.m, conAssign.m, glcAssign.m, snSolve.m, gnSolve.m, expDesign.m.

MEX-files Used

tomsol

See Also

ego.m

Warnings

Observe that when cancelling with CTRL+C during a run, some memory allocated by rbfSolve will not be deal- located. To deallocate, do:

>> clear cgolib

ego

Purpose

Solve general constrained mixed-integer global black-box optimization problems with costly objective functions.

The optimization problem is of the following form

Failed to parse (unknown function "\multicolumn"): {\displaystyle \begin{array}{cccccc} \min\limits_{x} & f(x) & & & & \\ s/t & x_{L} & \leq & x & \leq & x_{U} \\ & b_{L} & \leq & Ax & \leq & b_{U} \\ & c_{L} & \leq & c(x) & \leq & c_{U} \\ &\multicolumn{5}{c}{ ~x_{j} \in \MATHSET{N}\ ~~\forall j \in \MATHSET{I}}, \\ \end{array} }


where Failed to parse (unknown function "\MATHSET"): {\displaystyle f(x) \in \MATHSET{R}} ; Failed to parse (unknown function "\MATHSET"): {\displaystyle x_L,~x,~x_U \in \MATHSET{R}^d} ; the linear constraints are defined by Failed to parse (unknown function "\MATHSET"): {\displaystyle A \in \MATHSET{R}^{m_1 \times d}} , Failed to parse (unknown function "\MATHSET"): {\displaystyle b_L,~b_U \in \MATHSET{R}^{m_1}} ; and the nonlinear constraints are defined by Failed to parse (unknown function "\MATHSET"): {\displaystyle c_L,~c(x),~c_U \in~ \MATHSET{R}^{m_2}} . The variables are restricted to be integers, where Failed to parse (unknown function "\MATHSET"): {\displaystyle \MATHSET{I}} is an index subset of \{1,\ldots, used by all CGO solvers.

f (x) is assumed to be a costly function while c(x) is assumed to be cheaply computed. Any costly constraints can be treated by adding penalty terms to the objective function in the following way:

where weighting parameters wj have been added. The user then returns p(x) instead of f (x) to the CGO solver.

Calling Syntax

Result=ego(Prob,varargin) 
Result = tomRun('ego', Prob);

Description of Inputs

Problem description structure. The following fields are used:

X,F,CX The fields X,F,CX are used to define user given points. ExD = 5 (Percent = 0) needs this information. If ExD == 6-12,14-16 these points are included into the design.
Field Description
Name Name of the problem. Used for security when doing warm starts.
FUNCS.f Name of function to compute the objective function.
FUNCS.c Name of function to compute the nonlinear constraint vector.
x_L Lower bounds on the variables. Must be finite.
x_U Upper bounds on the variables. Must be finite.
b_U Upper bounds for the linear constraints.
b_L Lower bounds for the linear constraints.
A Linear constraint matrix.
c_L Lower bounds for the nonlinear constraints.
c_U Upper bounds for the nonlinear constraints.
WarmStart Set true (non-zero) to load data from previous run from cgoSave.mat and re- sume optimization from where the last run ended. If Prob.CGO.WarmStartInfo has been defined through a call to WarmDefGLOBAL, this field is used instead of the cgoSave.mat file. All CGO solvers uses the same mat-file and structure field and can read the output of one another.
MaxCPU Maximal CPU Time (in seconds) to be used.
user User field used to send information to low-level functions.
PriLevOpt Print level. 0 = silent. 1 = Summary, 2 = Printing each iteration, 3 = Info about local / global solution, 4 = Progress in x.
PriLevSub Print Level in subproblem solvers.
optParam Structure with optimization parameters. The following fields are used:
MaxFunc Maximal number of costly function evaluations, default 300 for rbfSolve and arbfMIP, and default 200 for ego. MaxFunc must be = 5000. If WarmStart = 1 and MaxFunc = nFunc (Number of f(x) used) then set MaxFunc := MaxFunc + nFunc.
IterPrint Print one information line each iteration, and the new x tried. Default IterPrint

= 1. fMinI means the best f(x) is infeasible. fMinF means the best f(x) is feasible (also integer feasible).

fGoal Goal for function value, not used if inf or empty.
eps_f Relative accuracy for function value, fTol == eps_f . Stop if |f - f Goal| = |f Goal| * fTol , if f Goal = 0. Stop if |f - f Goal| = fTol , if f Goal = 0. See the output field maxTri. bTol Linear constraint tolerance.
cTol Nonlinear constraint tolerance.
MaxIter Maximal number of iterations used in the local optimization on the re- sponse surface in each step. Default 1000, except for pure IP problems, then max(GO.MaxFunc, MaxIter);.
CGO Structure (Prob.CGO) with parameters concerning global optimization options.

The following general fields in Prob.CGO are used:

Percent Type of strategy to get the initial sampled values:
Percent Experimental Design ExD
Corner strategies
900 All Corners 1
997 xL + xU + adjacent corners 2
998 xU + adjacent corners 3
999 xL + adjacent corners 4

Deterministic Strategies||

0 User given initial points 5
94 DIRECT solver glbFast 6
95 DIRECT solver glcFast 6
96 DIRECT solver glbSolve 6
97 DIRECT solver glcSolve 6
98 DIRECT solver glbDirect 6
99 DIRECT solver glcDirect 6

Latin Based Sampling||

1 Maximin LHD 1-norm 7
2 Maximin LHD 2-norm 8
3 Maximin LHD Inf-norm 9
4 Minimal Audze-Eglais 10
5 Minimax LHD (only 2 dim) 11
6 Latin Hypercube 12
7 Orthogonal Samling 13

Random Strategies (pp in %)||

1pp Circle surrounding 14
2pp Ellipsoid surrounding 15
3pp Rectangle surrounding 16

Negative values of Percent result in constrained versions of the experimental design methods 7-16. It means that all points sampled are feasible with respect to all given constraints.

For ExD 5,6-12,14-16 user defined points are used.

nSample Number of sample points to be used in initial experimental design. nSample is used differently dependent on the value of Percent:
(n)Sample: ExD < 0 = 0 > 0 []
1 2d
6 |n|
7-11 d + 1 d + 1 max (d + 1, n) (d + 1)(d + 2)/2
12 LATIN(k)
13 |n|
14-16 d + 1

where LATIN = [21 21 33 41 51 65 65] and k = |nSample|. Otherwise nSample as input does not matter.

Description of the experimental designs:

ExD 1, All Corners. Initial points is the corner points of the box given by Prob.x L and Prob.x U. Generates 2d points, which results in too many points when the dimension is high.

ExD 2, Lower and Upper Corner point + adjacent points. Initial points are 2 * d + 2 corners: the lower left corner xL and its d adjacent corners xL + (xU (i) - xL (i)) * ei , i = 1, ..., d and the upper right corner xU and its d adjacent corners xU - (xU (i) - xL (i)) * ei , i = 1, ..., d

ExD 3. Initial points are the upper right corner xU and its d adjacent corners xU - (xU (i) - xL (i)) * ei , i = 1, ..., d

ExD 4. Initial points are the lower left corner xL and its d adjacent corners xL + (xU (i) - xL (i)) * ei , i = 1, ..., d

ExD 5. User given initial points, given as a matrix in CGO.X. Each column is one sampled point. If d = length(Prob.x L), then size(X,1) = d, size(X,2) = d + 1. CGO.F should be defined as empty, or contain a vector of corresponding f (x) values. Any CGO.F value set as NaN will be computed by solver routine.

ExD 6. Use determinstic global optimization methods to find the initial design. Current methods available (all DIRECT methods), dependent on the value of Percent:

99 = glcDirect, 98 = glbDirect, 97 = glcSolve, 96 = glbSolve, 95 = glcFast, 94 = glbFast.

ExD 7-11. Optimal Latin Hypercube Designs (LHD) with respect to different norms. The following norms and designs are available, dependent on the value of Percent:

1 = Maximin 1-Norm, 2 = Maximin 2-Norm, 3 = Maximin Inf-Norm, 4 = Audze-Eglais Norm, 5 = Minimax 2-Norm.

All designs taken from: http://www.spacefillingdesigns.nl/

Constrained versions will try bigger and bigger designs up to M = max(10 * d, nT rial) different designs, stopping when it has found nSample feasible points.

ExD 12. Latin hypercube space-filling design. For nSample < 0, k = |nSample| should in principle be the problem dimension. The number of points

sampled is:

k : 2 3 4 5 6 > 6 Points : 21 33 41 51 65 65

The call made is: X = daceInit(abs(nSample),Prob.x L,Prob.x U); Set nSample = [] to get (d+1)*(d+2)/2 sampled points:

d : 1 2 3 4 5 6 7 8 9 10 Points : 3 6 10 15 21 28 36 45 55 66

This is a more efficient number of points to use.

If CGO.X is nonempty, these points are verified as in ExD 5, and treated as al- ready sampled points. Then nSample additional points are sampled, restricted to be close to the given points.

Constrained version of Latin hypercube only keep points that fulfill the linear and nonlinear constraints. The algorithm will try up to M = max(10 * d, nT rial) points, stopping when it has found nSample feasible points (d + 1 points if nSample < 0).

ExD 13. Orthogonal Sampling, LH with subspace density demands.

ExD 14-16. Random strategies, the |Percent| value gives the percentage size of an ellipsoid, circle or rectangle around the so far sampled points that new points are not allowed in. Range 1%-50%. Recommended values 10% - 20%.

If CGO.X is nonempty, these points are verified as in ExD 5, and treated as already sampled points. Then nSample additional points are sampled, restricted to be close to the given points.

X A matrix of initial x values. One column for every x value. If ExD == 5, size(X,2) = dim(x)+1 needed.
F A vector of initial f (x) values. If any element is set to NaN it will be computed.
CX Optionally a matrix of nonlinear constraint c(x) values. If nonempty, then size(CX,2) == size(X,2). If any element is set as NaN, the vector c(x) = CX(:,i) will be recomputed.
RandState If = 0, rand(!state!, RandState) is set to initialize the pseudo-random genera- tor. If < 0, rand(!state!, 100 * clock) is set to give a new set of random values each run. If isnan(RandState), the random state is not initialized. RandState will influence if a stochastic initial experimental design is applied, see input Per- cent and nSample. RandState will also influence if using the multiMin solver, but the random state seed is not reset in multiMin. The state of the random generator is saved in the warm start output rngState, and the random genera- tor is reinitialized with this state if warm start is used. Default RandState = 0.
AddMP If = 1, add the midpoint as extra point in the corner strategies. Default 1 for any corner strategy, i.e. Percent is 900, 997, 998 or 999.
nTrial For experimental design CLH, the method generates M = max(10 * d, nT rial) trial points, and evaluate them until nSample feasible points are found. In the random designs, nTrial is the maximum number of trial points randomly generated for each new point to sample.
CLHMethod Different search strategies for finding feasible LH points. First of all, the least infeasible point is added. Then the linear feasible points are considered. If more points are needed still, the nonlinear infeasible points are added.

1 - Take the sampled infeasible points in order.

2 - Take a random sample of the infeasible points.

3 - Use points with lowest constraint error (cErr).

SCALE 0 - Original search space (default if any integer values).

1 - Transform search space to unit cube (default if no integers).

REPLACE 0 - No replacement, default for constrained problems.

1 - Large function values are replaced by the median.

> 1 - Large values Z are replaced by new values. The replacement is defined as Z := F M AX + log10(Z - F M AX + 1), where F M AX = 10REP LAC E , if min(F ) < 0 and F M AX = 10(ceil(log10(min(F )))+REP LAC E) , if min(F ) = 0. A new replacement is computed in every iteration, because min(F ) may change. Default REPLACE = 5, if no linear or nonlinear constraints.

LOCAL 0 - No local searches after global search. If RBF surface is inaccurate, might be an advantage.

1 - Local search from best points after global search. If equal best function values, up to 20 local searches are done.

SMOOTH 1 - The problem is smooth enough for local search using numerical gradient estimation methods (default).

0 - The problem is nonsmooth or noisy, and local search methods using numer- ical gradient estimation are likely to produce garbage search directions.

globalSolver Global optimization solver used for subproblem optimization. Default glcCluster (SMOOTH=1) or glcDirect (SMOOTH=0). If the global- Solver is glcCluster, the fields Prob.GO.maxFunc1, Prob.GO.maxFunc2, Prob.GO.maxFunc3, Prob.GO.localSolver, Prob.GO.DIRECT and other fields set in Prob.GO are used. See the help for these parameters in glcCluster.
localSolver Local optimization solver used for subproblem optimization. If not defined, the TOMLAB default constrained NLP solver is used.

- Special EGO algorithm parameters in Prob.CGO -

EGOAlg Main algorithm in the EGO solver (default EGOAlg == 1)

=1 Run expected improvement steps (modN=0,1,2,...). If no f (x) improve- ment, use DACE surface minimum (modN=-1) in 1 step

=2 Run expected improvement steps (modN=0) until ExpI/-yMin- ¡ Tol- ExpI for 3 successive steps (modN=1,2,3) without f (x) improvement (fRed = 0), where yMin is fMin transformed by TRANSFORM After 2 such steps (when modN=2), 1 step using the DACE surface minimum (modN=-1) is tried. If then fRed ¿0, reset to modN=0 steps.

pEst 1 - Estimate d-vector, p parameters (default), 0 - fix p=2.
pEst Norm parameters, fixed or estimated, also see p0, pLow, pUpp (default pEst = 0).

0 = Fixed constant p-value for all components (default, p0=1.99).

1 = Estimate one p-value valid for all components.

> 1 = Estimate d||||p parameters, one for each component.

p0 Fixed p-value (pEst==0, default = 1.99) or initial p-value (pEst == 1, default 1.9) or d-vector of initial p-values (pEst > 1, default 1.9*ones(d,1))
pLow Lower bound on p.

If pEst == 0, not used

if pEst == 1, lower bound on p-value (default 1.0)

if pEst > 1, lower bounds on p (default ones(d,1))

pUpp Upper bound on p.

If pEst == 0, not used

if pEst == 1, upper bound on p-value (default 2.0)

if pEst > 1, upper bounds on p (default 2*ones(d,1))

TRANSFORM Function value transformation.

0 - No transformation made.

1 - Median value transformation. Use REPLACE instead.

2 - log(y) transformation made.

3 - -log(-y) transformation made.

4 - -1/y transformation made.

Default EGO is computing the best possible transformation from the initial set of data. Note! No check is made on illegal y if user gives TRANSFORM.

EITRANSFORM Transformation of expected improvement function (default 1).

= 0 No transformation made.

= 1 - log(-f ) transformation made.

= 2 -1/f transformation made.

TolExpI Convergence tolerance for expected improvement (default 10-6 ).
SAMPLEF Sample criterion function:

0 = Expected improvment (default)

1 = Kushner's criterion (related option: KEPS)

2 = Lower confidence bounding (related option: LCBB)

3 = Generalized expected improvement (related option: GEIG)

4 = Maximum variance

5 = Watson and Barnes 2

KEPS The ε parameter in the Kushner's criterion (default: -0.01).

If KEPS > 0, then E = K EP S.

If KEPS < 0, then E = \|K EP S\| * fM in .

GEIG The exponent g in the generalized expected improvement function (default 2.0).
LCBB Lower Confidence Bounding parameter b (default 2.0).
GO Structure Prob.GO (Default values are set for all fields).

The following fields are used:

MaxFunc Maximal number of function evaluations in each global search.
MaxIter Maximal number of iterations in each global search.
DIRECT DIRECT solver used in glcCluster, either glcSolve or glcDirect(default).
maxFunc1 glcCluster parameter, maximum number of function evaluations in the first call. Only used if globalSolver is glcCluster, see help globalSolver.
maxFunc2 glcCluster parameter, maximum number of function evaluations in the second call. Only used if globalSolver is glcCluster, see help globalSolver.
maxFunc3 glcCluster parameter, maximum sum of function evaluations in repeated first calls to DIRECT routine when trying to get feasible. Only used if globalSolver is glcCluster, see help globalSolver.
localSolver The local solver used by glcCluster. If not defined, then Prob.CGO.localSolver is used
MIP Structure in Prob, Prob.MIP.

Defines integer optimization parameters. Fields used:

IntVars If empty, all variables are assumed non-integer.

If islogical(IntVars) (=all elements are 0/1), then 1 = integer variable, 0 = continuous variable. If any element > 1, IntVars is the indices for integer variables.

varargin Other arguments sent directly to low level functions.

Description of Outputs

Structure with result from optimization.

Output Description
x_k Matrix with the best points as columns.
f_k The best function value found so far.
Iter Number of iterations.
FuncEv Number of function evaluations.
ExitText Text string with information about the run.
ExitFlag Always 0.
CGO Subfield WarmStartInfo saves warm start information, the same information as in cgoSave.mat, see below.
Inform Information parameter.

0 = Normal termination.

1 = Function value f (x) is less than fGoal.

2 = Error in function value f (x), abs(f - f Goal) <= fTol, fGoal=0.

3 = Relative Error in function value f(x) is less than fTol, i.e. abs(f - fGoal)/abs(fGoal) <= f T ol.

4 = No new point sampled for N iteration steps.

5 = All sample points same as the best point for N last iterations.

6 = All sample points same as previous point for N last iterations.

7 = All feasible integers tried.

9 = Max CPU Time reached.

10 = Expected improvement low for three iterations.

Result Structure with result from optimization.
cgoSave.mat To make a warm start possible, all CGO solvers saves information in the file cgoSave.mat. The file is created independent of the solver, which enables the user to call any CGO solver using the warm start information. cgoSave.mat is a MATLAB mat-file saved to the current directory. If the parameter SAVE is 1, the CGO solver saves the mat file every iteration, which enables the user to break the run and restart using warm start from the current state. SAVE = 1 is currently always set by the CGO solvers. If the cgoSave.mat file fails to open for writing, the information is also available in the output field Result.CGO.WarmStartInfo, if the run was concluded without interruption. Through a call to WarmDefGLOBAL, the Prob structure can be setup for warm start. In this case, the CGO solver will not load the data from cgoSave.mat. The file contains the following variables:
Name Problem name. Checked against the Prob.Name field if doing a warmstart.
O Matrix with sampled points (in original space).
X Matrix with sampled points (in unit space if SCALE==1)
F Vector with function values (penalty added for costly Cc(x))
F_m Vector with function values (replaced).
F00 Vector of pure function values, before penalties.
Cc MMatrix with costly constraint values, C c(x).
nInit Number of initial points.
Fpen Vector with function values + additional penalty if infeasible using the linear constraints and noncostly nonlinear c(x).
fMinIdx Index of the best point found.
rngState Current state of the random number generator used.

Description

ego implements the algorithm EGO by D. R. Jones, Matthias Schonlau and William J. Welch presented in the paper "Efficient Global Optimization of Expensive Black-Box Functions".

Please note that Jones et al. has a slightly different problem formulation. The TOMLAB version of ego treats linear and nonlinear constraints separately.

ego samples points to which a response surface is fitted. The algorithm then balances between sampling new points and minimization on the surface.

ego and rbfSolve use the same format for saving warm start data. This means that it is possible to try one solver for a certain number of iterations/function evaluations and then do a warm start with the other. Example:

>> Prob	= probInit('glc_prob',1);		%   Set up problem structure
>> Result_ego = tomRun('ego',Prob);		%   Solve for a while with  ego
>> Prob.WarmStart = 1; 				%   Indicate a warm start
>> Result_rbf = tomRun('rbfSolve',Prob);	%   Warm start with rbfSolve

M-files Used

iniSolve.m, endSolve.m, conAssign.m, glcAssign.m

See Also

rbfSolve

Warnings

Observe that when cancelling with CTRL+C during a run, some memory allocated by ego will not be deallocated.

To deallocate, do:

>> clear egolib

arbfMIP

Purpose

Solve general constrained mixed-integer global black-box optimization problems with costly objective functions.

The optimization problem is of the following form

Failed to parse (unknown function "\multicolumn"): {\displaystyle \begin{array}{cccccc} \min\limits_{x} & f(x) & & & & \\ s/t & x_{L} & \leq & x & \leq & x_{U} \\ & b_{L} & \leq & Ax & \leq & b_{U} \\ & c_{L} & \leq & c(x) & \leq & c_{U} \\ &\multicolumn{5}{c}{ ~x_{j} \in \MATHSET{N}\ ~~\forall j \in \MATHSET{I}}, \\ \end{array} }


where Failed to parse (unknown function "\MATHSET"): {\displaystyle f(x) \in \MATHSET{R}} ; Failed to parse (unknown function "\MATHSET"): {\displaystyle x_L,~x,~x_U \in \MATHSET{R}^d} ; the linear constraints are defined by Failed to parse (unknown function "\MATHSET"): {\displaystyle A \in \MATHSET{R}^{m_1 \times d}} , Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle b_L,~b_U \in \MATHSET{R}^{m_1}} ; and the Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle m_2} nonlinear constraints are defined by Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle c_L,~c(x),~c_U \in~ \MATHSET{R}^{m_2}} . The variables Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle x_I} are restricted to be integers, where Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \MATHSET{I}} is an index subset of \{1,\ldots,Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle d<math>\}, possibly empty. It is assumed that the function <math>f(x)<math> is continuous with respect to all variables, even if there is a demand that some variables only take integer values. Otherwise it would not make sense to do the surrogate modeling of <math>f(x)} used by all CGO solvers.

f (x) is assumed to be a costly function while c(x) is assumed to be cheaply computed. Any costly constraints can be treated by adding penalty terms to the objective function in the following way:

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \begin{array}{ll} \min\limits_x & p(x)=f(x)+\sum\limits_{j} w_j\max\left(0,~c^j(x)-c_U^j, ~~c_L^j-c^j(x) \right), \end{array} }

where weighting parameters wj have been added. The user then returns p(x) instead of f (x) to the CGO solver.

Calling Syntax

Result = arbfMIP(Prob,varargin) 
Result = tomRun('arbfMIP', Prob);

Description of Inputs

Problem description structure. The following fields are used:

Input Description
Name Name of the problem. Used for security when doing warm starts.
FUNCS.f Name of function to compute the objective function.
FUNCS.c Name of function to compute the nonlinear constraint vector.
x_L Lower bounds on the variables. Must be finite.
x_U Upper bounds on the variables. Must be finite.
b_U Upper bounds for the linear constraints.
b_L Lower bounds for the linear constraints.
A Linear constraint matrix.
c_L Lower bounds for the nonlinear constraints.
c_U Upper bounds for the nonlinear constraints.
WarmStart Set true (non-zero) to load data from previous run from cgoSave.mat and re- sume optimization from where the last run ended. If Prob.CGO.WarmStartInfo has been defined through a call to WarmDefGLOBAL, this field is used instead of the cgoSave.mat file. All CGO solvers uses the same mat-file and structure field and can read the output of one another.
MaxCPU Maximal CPU Time (in seconds) to be used.
user User field used to send information to low-level functions.
PriLevOpt Print Level. 0 = silent. 1 = Summary 2 = Printing each iteration. 3 = Info about local / global solution. 4 = Progress in x.
PriLevSub Print Level in subproblem solvers, see help in snSolve and gnSolve.
f_Low Lower bound on the optimal function value. If defined, used to restrict the target values into interval \[f Low,min(surface)\].
optParam Structure with optimization parameters. The following fields are used:
MaxFunc Maximal number of costly function evaluations, default 300 for rbfSolve and arbfMIP, and default 200 for ego. MaxFunc must be = 5000. If WarmStart = 1 and MaxFunc = nFunc (Number of f(x) used) then set MaxFunc := MaxFunc + nFunc.
IterPrint Print one information line each iteration, and the new x tried. Default IterPrint

= 1. fMinI means the best f(x) is infeasible. fMinF means the best f(x) is feasible (also integer feasible).

fGoal|Goal for function value, not used if inf or empty.
eps_f Relative accuracy for function value, fTol == eps_f . Stop if |f - fGoal| = |f_Goal| * fTol , if fGoal = 0. Stop if |f - fGoal| = fTol , if fGoal = 0. See the output field maxTri.
bTol Linear constraint tolerance.
cTol Nonlinear constraint tolerance.
MaxIter Maximal number of iterations used in the local optimization on the re- sponse surface in each step. Default 1000, except for pure IP problems, then max(GO.MaxFunc, MaxIter);.
CGO Structure (Prob.CGO) with parameters concerning global optimization options.

The following general fields in Prob.CGO are used:

Percent Type of strategy to get the initial sampled values:
Percent Experimental Design ExD
Corner strategies
900 All Corners 1
997 xL + xU + adjacent corners 2
998 xU + adjacent corners 3
999 xL + adjacent corners 4
Deterministic Strategies
0 User given initial points 5
94 DIRECT solver glbFast 6
95 DIRECT solver glcFast 6
96 DIRECT solver glbSolve 6
97 DIRECT solver glcSolve 6
98 DIRECT solver glbDirect 6
99 DIRECT solver glcDirect 6
Latin Based Sampling
1 Maximin LHD 1-norm 7
2 Maximin LHD 2-norm 8
3 Maximin LHD Inf-norm 9
4 Minimal Audze-Eglais 10
5 Minimax LHD (only 2 dim) 11
6 Latin Hypercube 12
7 Orthogonal Samling 13
Random Strategies (pp in %)
1pp Circle surrounding 14
2pp Ellipsoid surrounding 15
3pp Rectangle surrounding 16

Negative values of Percent result in constrained versions of the experimental design methods 7-16. It means that all points sampled are feasible with respect to all given constraints.

For ExD 5,6-12,14-16 user defined points are used.

nSample Number of sample points to be used in initial experimental design. nSample is used differently dependent on the value of Percent:
(n)Sample:
ExD < 0 = 0 > 0 []
1 2d
6 |n|
7-11 d+ 1 d + 1 max (d + 1, n) (d + 1)(d + 2)/2
12 LATIN(k)
13 |n|
14-16 d + 1

where LATIN = [21 21 33 41 51 65 65] and k = |nSample|. Otherwise nSample as input does not matter.

Description of the experimental designs:

ExD 1, All Corners. Initial points is the corner points of the box given by Prob.x L and Prob.x U. Generates 2d points, which results in too many points when the dimension is high.

ExD 2, Lower and Upper Corner point + adjacent points. Initial points are

2 * d + 2 corners: the lower left corner xL and its d adjacent corners xL + (xU (i) - xL (i)) * ei , i = 1, ..., d and the upper right corner xU and its d adjacent corners xU - (xU (i) - xL (i)) * ei , i = 1, ..., d

ExD 3. Initial points are the upper right corner xU and its d adjacent corners xU - (xU (i) - xL (i)) * ei , i = 1, ..., d

ExD 4. Initial points are the lower left corner xL and its d adjacent corners xL + (xU (i) - xL (i)) * ei , i = 1, ..., d

ExD 5. User given initial points, given as a matrix in CGO.X. Each column is one sampled point. If d = length(Prob.x L), then size(X,1) = d, size(X,2) = d + 1. CGO.F should be defined as empty, or contain a vector of corresponding f (x) values. Any CGO.F value set as NaN will be computed by solver routine.

ExD 6. Use determinstic global optimization methods to find the initial design. Current methods available (all DIRECT methods), dependent on the value of Percent:

99 = glcDirect, 98 = glbDirect, 97 = glcSolve, 96 = glbSolve, 95 = glcFast, 94 = glbFast.

ExD 7-11. Optimal Latin Hypercube Designs (LHD) with respect to different norms. The following norms and designs are available, dependent on the value of Percent:

1 = Maximin 1-Norm, 2 = Maximin 2-Norm, 3 = Maximin Inf-Norm, 4 = Audze-Eglais Norm, 5 = Minimax 2-Norm.

All designs taken from: http://www.spacefillingdesigns.nl/

Constrained versions will try bigger and bigger designs up to M = max(10 * d, nT rial) different designs, stopping when it has found nSample feasible points.

ExD 12. Latin hypercube space-filling design. For nSample < 0, k = |nSample| should in principle be the problem dimension. The number of points

sampled is:

k : 2 3 4 5 6 > 6 Points : 21 33 41 51 65 65

The call made is: X = daceInit(abs(nSample),Prob.x L,Prob.x U); Set nSample = [ ] to get (d+1)*(d+2)/2 sampled points:

d : 1 2 3 4 5 6 7 8 9 10 Points : 3 6 10 15 21 28 36 45 55 66

This is a more efficient number of points to use.

If CGO.X is nonempty, these points are verified as in ExD 5, and treated as al- ready sampled points. Then nSample additional points are sampled, restricted to be close to the given points.

Constrained version of Latin hypercube only keep points that fulfill the linear and nonlinear constraints. The algorithm will try up to M = max(10 * d, nTrial) points, stopping when it has found nSample feasible points (d + 1 points if nSample < 0).

ExD 13. Orthogonal Sampling, LH with subspace density demands.

ExD 14-16. Random strategies, the |Percent| value gives the percentage size of an ellipsoid, circle or rectangle around the so far sampled points that new points are not allowed in. Range 1%-50%. Recommended values 10% - 20%.

If CGO.X is nonempty, these points are verified as in ExD 5, and treated as al- ready sampled points. Then nSample additional points are sampled, restricted to be close to the given points.

X,F,CX The fields X,F,CX are used to define user given points. ExD = 5 (Percent = 0) needs this information. If ExD == 6-12,14-16 these points are included into the design.
X A matrix of initial x values. One column for every x value. If ExD == 5, size(X,2) = dim(x)+1 needed.
F A vector of initial f (x) values. If any element is set to NaN it will be computed.
CX Optionally a matrix of nonlinear constraint c(x) values. If nonempty, then size(CX,2) == size(X,2). If any element is set as NaN, the vector c(x) = CX(:,i) will be recomputed.
RandState If >= 0, rand(!state!, RandState) is set to initialize the pseudo-random genera- tor. If < 0, rand(!state!, 100 * clock) is set to give a new set of random values each run. If isnan(RandState), the random state is not initialized. RandState will influence if a stochastic initial experimental design is applied, see input Per- cent and nSample. RandState will also influence if using the multiMin solver, but the random state seed is not reset in multiMin. The state of the random generator is saved in the warm start output rngState, and the random genera- tor is reinitialized with this state if warm start is used. Default RandState = 0.
AddMP If = 1, add the midpoint as extra point in the corner strategies. Default 1 for any corner strategy, i.e. Percent is 900, 997, 998 or 999.
nTrial For experimental design CLH, the method generates M = max(10 * d, nT rial) trial points, and evaluate them until nSample feasible points are found. In the random designs, nTrial is the maximum number of trial points randomly generated for each new point to sample.
CLHMethod Different search strategies for finding feasible LH points. First of all, the least infeasible point is added. Then the linear feasible points are considered. If more points are needed still, the nonlinear infeasible points are added.

1 - Take the sampled infeasible points in order.

2 - Take a random sample of the infeasible points.

3 - Use points with lowest constraint error (cErr).

SCALE 0 - Original search space (default if any integer values).

1 - Transform search space to unit cube (default if no integers).

REPLACE 0 - No replacement, default for constrained problems.

1 - Large function values are replaced by the median.

> 1 - Large values Z are replaced by new values. The replacement is defined as Z := F M AX + log10(Z - F M AX + 1), where F M AX = 10REP LAC E , if min(F ) < 0 and F M AX = 10(ceil(log10(min(F )))+REP LAC E) , if min(F ) = 0. A new replacement is computed in every iteration, because min(F ) may change. Default REPLACE = 5, if no linear or nonlinear constraints.

LOCAL 0 - No local searches after global search. If RBF surface is inaccurate, might be an advantage.

1 - Local search from best points after global search. If equal best function values, up to 20 local searches are done.

SMOOTH 1 - The problem is smooth enough for local search using numerical gradient estimation methods (default).

0 - The problem is nonsmooth or noisy, and local search methods using numer- ical gradient estimation are likely to produce garbage search directions.

globalSolver Global optimization solver used for subproblem optimization. Default glcCluster (SMOOTH=1) or

glcDirect (SMOOTH=0). If the global Solver is glcCluster, the fields Prob.GO.maxFunc1, Prob.GO.maxFunc2, Prob.GO.maxFunc3, Prob.GO.localSolver, Prob.GO.DIRECT and other fields set in Prob.GO are used. See the help for these parameters in glcCluster.

localSolver Local optimization solver used for subproblem optimization. If not defined, the TOMLAB default constrained NLP solver is used.

- Special RBF algorithm parameters in Prob.CGO -

rbfType Type of radial basis function: 1 - thin plate spline; 2 - Cubic Spline (default); 3 - Multiquadric; 4 - Inverse multiquadric; 5 - Gaussian; 6 - Linear.
idea Global search type, always idea = 1, i.e. use fnStar values. if fStarRule =3, then N=1 default, otherwise N=4 default. By default idea =1, fStarRule =1, i.e. N =4. To change N, see below.
N Cycle length in idea 1 (default N=1 for fStarRule 3, otherwise default N=4) or idea 2 (always N=3).
infStep If =1, add search step with target value -8 first in cycle. Default 0. Always

=1 for the case idea =1, fStarRule =3.

fStarRule minsn \|k = N, ..., 0.

These strategies had the following names in Gutmanns thesis: III, II, I.

DeltaRule 1 = Skip large f(x) when computing f(x) interval ?. 0 = Use all points. Default 1.
eps_sn Relative tolerance used to test if the minimum of the RBF surface, minsn , is sufficiently lower than the best point (fM in ) found (default is 10-7 ).
MaxCycle Max number of cycles without progress before stopping, default 10.
GO Structure Prob.GO (Default values are set for all fields).
MaxFunc Maximal number of function evaluations in each global search.
MaxIter Maximal number of iterations in each global search.
DIRECT DIRECT solver used in glcCluster, either glcSolve or glcDirect(default).
maxFunc1 glcCluster parameter, maximum number of function evaluations in the first call. Only used if globalSolver is glcCluster, see help globalSolver.
maxFunc2 glcCluster parameter, maximum number of function evaluations in the second call. Only used if globalSolver is glcCluster, see help globalSolver.
maxFunc3 glcCluster parameter, maximum sum of function evaluations in repeated first calls to DIRECT routine when trying to get feasible. Only used if globalSolver is glcCluster, see help globalSolver. localSolver The local solver used by glcCluster. If not defined, then Prob.CGO.localSolver is used MIP Structure in Prob, Prob.MIP.

Defines integer optimization parameters. Fields used:

IntVars If empty, all variables are assumed non-integer.

If islogical(IntVars) (=all elements are 0/1), then 1 = integer variable, 0 = continuous variable. If any element > 1, IntVars is the indices for integer variables.

varargin Other parameters directly sent to low level routines.

Description of Outputs

Structure with result from optimization. The following fields are changed:

Output Description
x_k Matrix with the best points as columns.
f_k The best function value found so far.
Iter Number of iterations.
FuncEv Number of function evaluations.
ExitText Text string with information about the run.
ExitFlag Always 0.
CGO Subfield WarmStartInfo saves warm start information, the same information as in cgoSave.mat, see below.
Inform Information parameter.

0 = Normal termination.

1 = Function value f(x) is less than fGoal.

2 = Error in function value f (x), |f - f Goal| = f T ol, f Goal = 0.

3 = Relative Error in function value f (x) is less than fTol, i.e. |f - f Goal|/|f Goal| = fTol.

4 = No new point sampled for MaxCycle iteration steps.

5 = All sample points same as the best point for MaxCycle last iterations.

6 = All sample points same as previous point for MaxCycle last iterations.

7 = All feasible integers tried.

9 = Max CPU Time reached.

cgoSave.mat To make a warm start possible, all CGO solvers saves information in the file cgoSave.mat. The file is created independent of the solver, which enables the user to call any CGO solver using the warm start information. cgoSave.mat is a MATLAB mat-file saved to the current directory. If the parameter SAVE is 1, the CGO solver saves the mat file every iteration, which enables the user to break the run and restart using warm start from the current state. SAVE = 1 is currently always set by the CGO solvers. If the cgoSave.mat file fails to open for writing, the information is also available in the output field Result.CGO.WarmStartInfo, if the run was concluded without interruption. Through a call to WarmDefGLOBAL, the Prob structure can be setup for warm start. In this case, the CGO solver will not load the data from cgoSave.mat. The file contains the following variables:
Name Problem name. Checked against the Prob.Name field if doing a warmstart.
O Matrix with sampled points (in original space).
X Matrix with sampled points (in unit space if SCALE==1)
F Vector with function values (penalty added for costly Cc(x))
F m Vector with function values (replaced).
F00 Vector of pure function values, before penalties.
Cc MMatrix with costly constraint values, C c(x). nInitNumber of initial points.
Fpen Vector with function values + additional penalty if infeasible using the linear constraints and noncostly nonlinear c(x).
fMinIdx Index of the best point found.
rngState Current state of the random number generator used.

Description

arbfMIP implements the Adaptive Radial Basis Function (ARBF) algorithm presented in \[11\]. The ARBF method handles linear equality and inequality constraints, and nonlinear equality and inequality constraints, as well as mixed-integer problems.

M-files Used

daceInit.m, iniSolve.m, endSolve.m, conAssign.m, glcAssign.m, snSolve.m, gnSolve.m, expDesign.m.

MEX-files Used

tomsol

See Also

rbfSolve.m and ego.m

Warnings

Observe that when cancelling with CTRL+C during a run, some memory allocated by arbfMIP will not be deallocated. To deallocate, do:

''>> ''clear cgolib

rbfSolve description

Following is a detailed description of the rbfSolve algorithm.

Summary

The manual considers global optimization of costly objective functions, i.e. the problem of finding the global minimum when there are several local minima and each function value takes considerable CPU time to compute. Such problems often arise in industrial and financial applications, where a function value could be a result of a time- consuming computer simulation or optimization. Derivatives are most often hard to obtain, and the algorithms presented make no use of such information.

The emphasis is on a new method by Gutmann and Powell, A radial basis function method for global optimization. This method is a response surface method, similar to the Efficient Global Optimization (EGO) method of Jones. The TOMLAB implementation of the Radial Basis Function (RBF) method is described in detail.

Introduction

The task of global optimization is to find the set of parameters x in the feasible region Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \Omega \subset R^d} for which the objective function f(x) obtains its smallest value. In other words, a point Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle x^{\ast}} is a global optimizer to f (x) on Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \Omega} , if Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f(x^{\ast}) \leq f(x)} . On the other hand, a point xˆ is a local optimizer to f (x), if f (x) = f (x) for all x in some neighborhood around x. Obviously, when the objective function has several local minima, there could be solutions that are locally optimal but not globally optimal and standard local optimization techniques are likely to get stuck before the global minimum is reached. Therefore, some kind of global search is needed to find the global minimum with some reliability.

Previously a Matlab implementations of the DIRECT has been made, the new constrained DIRECT and the Efficient Global Optimization (EGO) algorithms. The implementations are part of the TOMLAB optimization environment. The implementation of the DIRECT algorithm is further discussed and analyzed in Bjorkman, Holmström. Since the objective functions in our applications often are expensive to compute, we have to focus on very efficient methods. At the IFIP TC7 Conference on System Modelling and Optimization in Cambridge 1999, Hans-Martin Gutmann presented his work on the RBF algorithm. The idea of the RBF algorithm is to use radial basis function interpolation to define a utility function (Powell). The next point, where the original objective function should be evaluated, is determined by optimizing on this utility function. The combination of our need for efficient global optimization software and the interesting ideas of Powell and Gutmann led to the development of an improved RBF algorithm implemented in Matlab.

The RBF Algorithm

Our RBF algorithm is based on the ideas presented by Gutmann, with some extensions and further develop- ment. The algorithm is implemented in the Matlab routine rbfSolve.

The RBF algorithm deals with problems of the form

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \begin{array}{ll} \min\limits_{x} & f(x) \\ \mathrm{s.t.} & \begin{array}{ccccc} x_{L} & \leq & x & \leq & x_{U} \end{array}, \end{array} }

where Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f \in R} and Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle x, x_{L}, x_{U} \in R^{d}} . We assume that no derivative information is available and that each function evaluation is very expensive. For example, the function value could be the result of a time-consuming experiment or computer simulation.

Description of the Algorithm

We now consider the question of choosing the next point where the objective function should be evaluated. The idea of the RBF algorithm is to use radial basis function interpolation and a measure of 'bumpiness' of a radial function, σ say. A target value Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*} is chosen that is an estimate of the global minimum of f . For each y ?/ \{x1 , . . . , xn \} there exists a radial basis function that satisfies the interpolation conditions

The next point xn+1 is calculated as the value of y in the feasible region that minimizes s(sy ). It turns out that the function y ?-? s(sy ) is much cheaper to compute than the original function.

Here, the radial basis function interpolant sn has the form

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle s_n(x) = \sum\limits_{i=1}^n\lambda_i \phi\left( \left\|x-x_i \right\|_2 \right)+b^Tx + a, }

with Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \lambda_1,\ldots,\lambda_n \in R} , Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle b \in R^d} , Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle a \in R} and Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \phi} is either cubic with Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \phi(r)=r^3} or the thin plate spline Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \phi(r)=r^2 \log r} . Gutmann considers other choices of Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \phi} and of the additional polynomial, but later concludes that the situation in the multiquadric and Gaussian cases is disappointing.

The unknown parameters Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \lambda_i} , b and a are obtained as the solution of the system of linear equations

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \left(\begin{array}{ll} \Phi & P \\ P^T & 0 \end{array} \right) \left(\begin{array}{c} \lambda \\ c \end{array} \right)= \left(\begin{array}{c} F \\ 0 \end{array} \right) }


where Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle Phi} is the n × n matrix with Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \Phi_{ij}=\phi\left(\left\|x_i-x_j\right\|_2\right)} and

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P = \left(\begin{array}{cc} x_1^T & 1 \\ x_2^T & 1 \\ . & . \\ . & . \\ x_n^T & 1 \end{array} \right), \lambda = \left(\begin{array}{c} \lambda_1 \\ \lambda_2 \\ . \\ . \\ \lambda_n \end{array} \right), c = \left(\begin{array}{c} b_1 \\ b_2 \\ . \\ . \\ b_d \\ a \end{array} \right), F = \left(\begin{array}{c} f(x_1) \\ f(x_2) \\ . \\ . \\ f(x_n) \end{array} \right). }



Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle s_y} could be obtained accordingly, but there is no need to do that as one is only interested in Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \sigma(s_y)} . Powell shows that if the rank of P is d + 1, then the matrix

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \left(\begin{array}{cc} \Phi & P \\ P^T & 0 \end{array} \right) }

is nonsingular and the linear system (4) has a unique solution.

For sn it is

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \sigma(s_n) = \sum\limits_{i=1}^n \lambda_i s_n(x_i). }

Further, it is shown that Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \sigma(s_y)} is

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \sigma(s_y) = \sigma(s_n) + \mu_n(y)\left[s_n(y)-f_n^*\right]^2,\ \ %y \in \Omega \setminus \left\{x_1, \ldots ,x_n \right\}. y \notin \{x_1, \ldots ,x_n\}. }

Thus minimizing Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \sigma(s_y)} subject to constraints is equivalent to minimizing gn defined as

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle g_n(y) = \mu_n(y)\left[s_n(y)-f_n^*\right]^2,\ \ y \in \Omega \setminus \left\{x_1, \ldots ,x_n \right\}, }

where Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mu_n(y)} is the coefficient corresponding to y of the Lagrangian function L that satisfies Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle L(x_i)=0$, $i=1, \ldots, n} and L(y) = 1. It can be computed as follows. F is extended to

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \Phi_y = \left( \begin{array}{cc} \Phi & \phi_y \\ \phi_y^T & 0 \end{array} \right), }

where Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle (\phi_{y})_i=\phi(\left\|y-x_i\right\|_2)} , Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle i=1, \ldots ,n} and P is extended to

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P_y = \left( \begin{array}{c} P \\ y^T \ \ 1 \end{array} \right). }

Then Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mu_n(y)} is the (n + 1)-th component of Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle v \in R^{n+d+2}} that solves the system

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \left(\begin{array}{cc} \Phi_y & P_y \\ P_y^T & 0 \end{array} \right) v = \left(\begin{array}{l} 0_{n} \\ 1 \\ 0_{d+1} \end{array} \right). }

We use the notation 0n and Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle 0_{d+1}} for column vectors with all entries equal to zero and with dimension n and (d + 1), respectively. The computation of Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mu_n(y)} is done for many different y when minimizing Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle g_n(y)} . This requires Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle O(n^3)} operations if not exploiting the structure of Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \Phi_y} and Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P_y} . Hence it does not make sense to solve the full system each time. A better alternative is to factorize the interpolation matrix and update the factorization for each y. An algorithm that requires Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle O(n^2)} operations is described in #Factorizations and Updates.

When there are large differences between function values, the interpolant has a tendency to oscillate strongly. It might also happen that Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \min s_n(y)} is much lower than the best known function value, which leads to a choice of Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*} that overemphasizes global search. To handle these problems, large function values are in each iteration replaced by the median of all computed function values. Note that Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mu_n} and Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle g_n} are not defined at Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle x_1, \ldots ,x_n} and

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \lim\limits_{y \rightarrow x_i} \mu_n(y) = \infty, ~~i=1, \ldots, n. }

This will cause problems when Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mu_n} is evaluated at a point close to one of the known points. The function Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle h_n(x)} defined by

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle h_n(x) ~=~ \left\{ \begin{array}{cl} \frac{1}{g_n(x)}, & x \notin\left\{x_1, \ldots ,x_n\right\} \\ 0, & x \in\left\{x_1, \ldots ,x_n\right\} \end{array} \right. }

is differentiable everywhere on Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \Omega} , and is thus a better choice as objective function. Instead of minimizing Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle g_n(y)} one may minimize Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle -h_n(y)} . In our implementation we instead minimize Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle -\log (h_n(y))} . By this we avoid a flat minimum and numerical trouble when Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle h_n(y)} is very small.

The Choice of f *

For the value of Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle $f_n^*} it should hold that

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^* \in \left[-\infty,\min\limits_{y \in \Omega} s_n(y)\right]. }

The case Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*=\min\limits_{y \in \Omega} s_n(y)} is only admissible if Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \min\limits_{y \in \Omega} s_n(y)<s_n(x_i)$, $i=1, \ldots, n} . There are two special cases for the choice of Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*} . In the case when Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*=\min\limits_{y \in \Omega} s_n(y)} , then minimizing is equivalent to

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \min\limits_{y \in \Omega} s_n(y). }

In the case when Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*=-\infty} , then minimizing is equivalent to

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \min\limits_{y \in \Omega \setminus \left\{x_1, \ldots ,x_n \right\} } \mu_n(y). }


So how should Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*} be chosen? If Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*=-\infty} , then the algorithm will choose the new point in an unexplored region, which is good from a global search point of view, but the objective function will not be exploited at all. If Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*=\min\limits_{y \in \Omega} s_n(y)} , the algorithm will show good local behaviour, but the global minimum might be missed. Therefore, there is a need for a mixture of values for Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*} close to and far away from Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \min\limits_{y \in \Omega} s_n(y)} . Gutmann describes two different strategies for the choice of Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*} .

The first strategy, denoted idea 1, is to perform a cycle of length N + 1 and choose Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*} as

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^* = \min\limits_{y \in \Omega} s_n(y)-W \cdot \left(\max\limits_i f(x_i)- \min\limits_{y \in \Omega} s_n(y)\right), }

with

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle W = \left[\frac{(N-(n-n_{init}))\mathrm{mod}(N+1)}{N}\right]^2, }

where Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle n_{init}} is the number of initial points. Here, N = 5 is fixed and Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \max\limits_i f(x_i)} is not taken over all points, except for the first step of the cycle. In each of the subsequent steps the Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle n-n_{max}} points with largest function value are removed (not considered) when taking the maximum. Hence the quantity Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \max\limits_i f(x_i)} is decreasing until the cycle is over. Then all points are considered again and the cycle starts from the beginning. More formally, if Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle (n-n_{init})\mathrm{mod}(N+1)=0} , Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle n_{max}=n} , otherwise

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle n_{max}=\max\left\{2,n_{max}-\mathrm{floor}((n-n_{init})/N) }

The second strategy, denoted idea 2, is to consider Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*} as the optimal value of

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \begin{array}{ll} \min & f^*(y) \\ \mathrm{s.t.} & \mu_n(y)\left[s_n(y)-f^*(y) \right]^2 \leq \alpha_n^2 \\ & y \in \Omega, \end{array} }

and then perform a cycle of length N + 1 on the choice of an . Here, N = 3 is fixed and

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \begin{array}{lll} \alpha_n & = & \frac{1}{2}\left( \max\limits_i f(x_i)- \min\limits_{y \in \Omega} s_n(y) \right),\ \ n=n_0,n_0+1 \\ \alpha_{n_0+2} & = & \min\left\{1,\frac{1}{2}\left( \max\limits_i f(x_i)- \min\limits_{y \in \Omega} s_n(y) \right) \right\} \\ \alpha_{n_0+3} & = & 0, \end{array} }

where Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle n_0} is set to n at the beginning of each cycle. For this strategy, Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \max\limits_i f(x_i)} is taken over all points in all parts of the cycle.

Note that for a fixed y the optimal Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f^*(y)} is the one for which

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mu_n(y)\left[s_n(y)-f^*(y)\right]^2 = \alpha_n^2. }

Substituting this equality constraint into the objective simplifies the problem to the minimization of

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f^*(y) = s_n(y) - \alpha_n/\sqrt{\mu_n(y)}. }

Denoting the minimizer by Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle y^*} , and choosing Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*=f^*(y^*)} , it is evident that Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle y^*} minimizes Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mu_n(y)\left[s_n(y)-f_n^*\right]^2} and hence Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle g_n(y)} .

For both strategies (idea 1 and idea 2), a check is performed when Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle <(n-n_{init})\mathrm{mod}(N+1)=N} . This is the stage when a purely local search is performed, so it is important to make sure that the minimizer of sn is not one of the interpolation points or too close to one. The test used is

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_{min}-\min\limits_{y \in \Omega} s_n(y) \leq 10^{-4} \max\left\{1,|f_{min}|\right\}, }

where Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_{min}} is the best function value found so far, i.e. Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \min\limits_i f(x_i)} , Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle i=1, \ldots ,n} . For the first strategy (idea 1), then

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*=\min\limits_{y \in \Omega} s_n(y)-10^{-2}\max\left\{1,|f_{min}|\right\}, }

otherwise Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f_n^*} is set to 0. For the second strategy (idea 2), then an (or more correctly Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \alpha_{n_0+3}} ) is set

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \alpha_{n_0+3}=\min\left\{1,\frac{1}{2}\left( \max\limits_i f(x_i)- \min\limits_{y \in \Omega} s_n(y) \right) \right\}, }

otherwise Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \alpha_{n_0+3}} is set to 0.

Factorizations and Updates

In Powell, a factorization algorithm is presented for the solution. The algorithm makes use of the conditional definiteness of Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \Phi} , i.e. Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \lambda^T \Phi \lambda > 0, ~\lambda \neq 0} and Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P^T \lambda=0} . If

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P = \left(\begin{array}{cc} Y & Z \end{array} \right) \left(\begin{array}{c} R \\ 0 \end{array} \right) }

is the QR decomposition of P , then the columns of Z span the null space of Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P^T} , and every Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \lambda} with Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P^T \lambda=0} can be expressed as Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \lambda=Z z} for some vector z. Thus the conditional positive definiteness implies that

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle z^T Z^T \Phi Z z > 0, ~z \in R^{n-d-1} ~~\backslash~ \{0\}. }

This shows that Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle Z^T \Phi Z} is positive definite, and thus its Cholesky factorization

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle Z^T \Phi Z = L L^T }

exists. This property can be used to solve (4) as follows. Consider the interpolation condition Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \Phi \lambda+Pc=F} in (4). Multiply from left by Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle Z^T} and replace Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \lambda} by Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle Z z} . Because Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle Z^T P=0} , the interpolation condition simplifies to

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle Z^T \Phi Z z = Z^T F. }

Solving this system using the Cholesky factorization gives z. Then compute Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \lambda=Z z} and solve

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P c = F-\Phi \lambda }

for c using the QR decomposition of P as

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle Rc = Y^T\! (F - \Phi \lambda). }

The same principle can be applied to solve (12) for a given y to get Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mu_n(y)} . In analogy to the discussion above, if the extended matrices Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \Phi_y} and Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P_y} in (10) and (11), respectively, are given, and if

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle Z_{y}^T P_y = 0 }

and

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle Z_{y}^T \Phi_y Z_{y} = L_y L_y^T }


is the Cholesky factorization, then the vector

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle v = Z_{y} z(y) }

yields Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mu_n(y) = v_{n+1}} , where z(y) solves

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle Z_{y}^T \Phi_y Z_{y} z = Z_{y} \left( \begin{array}{c} 0_n \\ 1 \end{array} \right). }

The Cholesky factorization is the most expensive part of this procedure. It requires Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle (n^3)} operations. As Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mu_n(y)} must be computed for many different y this is inacceptable. However, if one knows the QR factors of P and the Cholesky factor of Z T FZ , the QR factorization of Py and the new Cholesky factor Ly can be computed in Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle O(n^2)} operations.

The new Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \Phi(y)} is

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \Phi_y = \left( \begin{array}{cc} \Phi & \phi_y \\ \phi_y^T & 0 \end{array} \right), }

where Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \phi_y)_i=\phi(\left\|y-x_i\right\|_2)} , Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle i=1, \ldots ,n} . The new P (y) is

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P_y = \left( \begin{array}{c} P \\ y^T \ \ 1 \end{array} \right). }

Compute the QR factorization of Py, defined in (10). Given Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P=QR} , the QR factorization of Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P_y} may be written as

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P_y = Q_y R_y = \left( \begin{array}{cc} Q & 0 \\ 0 & 1 \end{array} \right) H R_y, }

where Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle H} is an orthogonal matrix obtained by d + 1 Givens rotations and for Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle i=d+2, \ldots, n} the i-th column of H is the i-th unit vector. Denote Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle B=Q^T \Phi Q} . Using Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \Phi_y} as defined in (10) consider the expanded B matrix Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \begin{array}{lll} B_y & = & Q_y^T \Phi_y Q_y = H^T \left( \begin{array}{cc} Q^T & 0 \\ 0 & 1 \end{array} \right) \Phi_y \left( \begin{array}{cc} Q & 0 \\ 0 & 1 \end{array} \right) H = \\ & = & H^T \left( \begin{array}{cc} B & Q^T \phi_y \\ \phi_y^T Q & 0 \end{array} \right) H. \end{array} }

Multiplications from the right and left with H affects only the first (d + 1) rows and columns and the last row and the last columns of the matrix in the middle. (Remember, d is the dimension of the problem). Hence

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle B_y = \left( \begin{array}{ccc} \ast & \ast & \ast \\ \ast & Z^T \Phi Z & v \\ \ast & v^T & \gamma \end{array} \right), }

where * denotes entries not important for the moment. From the form of By it follows that

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle Z_{y}^T \Phi Z_{y} = \left( \begin{array}{cc} Z^T \Phi Z & v \\ v^T & \gamma \end{array} \right) }

holds. The Cholesky factorization of Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle Z^T \Phi Z} is already known. The new Cholesky Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle L_y} factor is found by solving the lower triangular system Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle L l = v} for l, computing Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \beta=\sqrt{\gamma-l^Tl}} , and setting

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle L_y = \left( \begin{array}{cc} L & 0 \\ l^T & \beta \end{array} \right). }

It is easily seen that Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle L_y L_y^T = Z_{y}^T \Phi_y Z_{y}} because

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \begin{array}{lll} L_y L_y^T & = & \left( \begin{array}{cc} L & 0 \\ l^T & \beta \end{array} \right) \left( \begin{array}{cc} L^T & l \\ 0 & \beta \end{array} \right) = \left( \begin{array}{cc} L L^T & L l \\ l^T L & l^T l + \beta^2 \end{array} \right) = \\ & = & \left( \begin{array}{cc} Z^T \Phi Z & v \\ v^T & \gamma \end{array} \right) = Z_{y}^T \Phi_y Z_{y}. \end{array} }

Note that in practice we do the following: First compute the factorization of P , i.e. Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle P_y=Q_yR_y} , using Givens rotations. Then, since we are only interested in v and Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \gamma} in (42), it is not necessary to compute the matrix By in (41). Setting v to the last column in Qyand computing Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \tilde{v}=\Phi_y^T \hat{v}=\Phi_y \hat{v}} (Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \Phi_y} is symmetric), gives v and Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \gamma} by multiplying the last (n - d) columns in Qy by Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle tilde{v}} , i.e.


Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \left( \begin{array}{cc} v \\ \gamma \end{array} \right)= \begin{array}{ll} Q_{y_{\cdot i}}^T \tilde{v}, & i=d+2, \ldots ,n+1. \end{array} }

Using this algorithm, v and γ are computed using ((n + 1) + (n - d)) inner products instead of the two matrix multiplications in (41).

Note that the factorization algorithm is a normal 'null-space' method for solving an optimization problem involving linear equality constraints. The system of linear equations in (4) defines the necessary conditions for a stationary point to the unconstrained quadratic programming (QP) problem

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \min_{\lambda, c}\ \half \lambda\T \Phi \lambda + \lambda\T (P c -F). }

Viewing c as Lagrange multipliers for the linear equalities in (4), (47) is equivalent to the QP problem in ? defined as

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \min_{\lambda}\ \half \lambda\T \Phi \lambda - F\T \lambda \text{subject to} P\T \lambda = 0. }

The first condition in the conditional positive definiteness definition is the same as saying that the reduced Hessian must be positive definite at the solution of the QP problem if that solution is to be unique.

The type of update procedure described above is suitable each time an optimal point y = xn+1 is added. However, when evaluating all candidates y an even more efficient algorithm can be formulated. What is needed is a black-box procedure to solve linear systems with a general right-hand side:

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mtx{cc}{\Phi & P \\ P^T & 0} \mtx{c} {\lambda \\ c} = \mtx{c} {g \\ r}. }

Using the QR-factorization in (28) the steps


Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle R\T v &=& r, \\ Z\T \Phi Zw &=& Z\T (g - \Phi Yv), \\ \lambda &=& Yv + Zw, \\ R c &=& Y\T(g - \Phi \lambda) }

simplify when r = 0 as in (4), but all steps are useful for solving the extended system (49); see next.

For each of many vectors y, the extended system takes the form

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mtx{cc|c}{\Phi & \phi & P \\ \phi^T & 0 & p^T \\ \hline P^T & p & 0} \mtx{c} {\lambar \\ \mu \\ \cbar} = \mtx{c} { 0 \\ 1 \\ 0}, }

where Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle p\T = (\,y^T\ \ 1\,)} . This permutes to

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mtx{cc|c}{\Phi & P & \phi \\ P^T & 0 & p \\ \hline \phi^T & p^T & 0} \mtx{c} {\lambar \\ \cbar \\ \mu} = \mtx{c} { 0 \\ 0 \\ 1}, }

which may be solved by block-LU factorization (also known as the Schur-complement method). It helps that most of the right-hand side is zero. The solution is given by the steps

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \mtx{cc}{\Phi & P \\ P^T & 0} \mtx{c} {\lamhat \\ \chat} &=& \mtx{c} {\phi \\ p}, \\ \mu &=& -1 / (\phi\T \lamhat + p\T \chat), \\ \mtx{c} {\lambar \\ \cbar} &=& -\mu \mtx{c} {\lamhat \\ \chat}. }

Thus, each y requires little more than solving for Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle (\lamhat,\chat)} using the current factorizations (two operations each with Q, R and L). This is cheaper than updating the factors for each y, and should be reliable unless the matrix in (4) is nearly singular. The updating procedure is best numerically, and it is still needed once when the final Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle y = x_{n+1}} is chosen.

A Compact Algorithm Description

Section #Description of the Algorithm-#Factorizations and Updates described all the elements of the RBF algorithm as implemented in our Matlab routine rbfSolve, but our discussion has covered several pages. We now summarize everything in a compact step-by-step description. Steps 2, 6 and 7 are different in idea 1 and idea 2.

2: Start a cycle of length 6.||Start a cycle of length 4. 3: If the maximum number of function evalua- tions reached, quit. 4: Compute the radial basis function interpolant sn by solving the system of linear equations (4). 5: Solve the minimization problem min sn (y). y?? 6: Compute f * in (18) corresponding to the current position in the cycle.||Compute an in (22) corresponding to the current position in the cycle. 7: New point xn+1 is the value of y that mini- mizes gn (y) in (9).||New point xn+1 is the value of y that min- imizes f *(y) in (24). 8: Compute Fn+1 = f (xn+1 ) and set n = n + 1. 9: If end of cycle, go to 2. Otherwise go to 4.
idea 1 idea 2
1: Choose n initial points x1 , . . . , xn (normally the 2d box corner points defined by the variable bounds). Compute Fi = f (xi ), i = 1, 2, . . . , n and set ninit = n.

Some Implementation Details

The first question that arise is how to choose the points Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle x_1, \ldots ,x_{n_{init}}} to include in the initial set. We only consider box constrained problems, and choose the corners of the box as initial points, i.e. Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle n_{init}=2^d} . Starting with other points is likely to lead to the corners during the iterations anyway. But as Gutmann suggests, having a "good" point beforehand, one can include it in the initial set.

The subproblem

Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle \begin{array}{ll} \min\limits_{y \in \Omega} & s_n(y) \end{array}, }

is itself a problem which could have more than one local minima. To solve (51) (at least approximately), we start from the interpolation point with the least function value, i.e. Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle mathrm{argmin} f(x_i)} , Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle i=1, \ldots ,n} , and perform a local search. In many cases this leads to the minimum of sn . Of course, there is no guarantee that it does. We use analytical expressions for the derivatives of sn and perform the local optimization using ucSolve in TOMLAB running the inverse BFGS algorithm.

To minimize Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle g_n(y)} for the first strategy, or Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f^*(y)} for the second strategy, we use our Matlab routine glbSolve implementing the DIRECT algorithm (see the TOMLAB manual). We run glbSolve for 500 function evaluations and choose xn+1 as the best point found by glbSolve. When Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle (n-n_{init})\mathrm{mod}(N+1)=N} (when a purely local search is performed) and the minimizer of sn is not too close to any of the interpolation points, i.e. (25) is not true, glbSolve is not used to minimize Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle g_n(y)} or Failed to parse (SVG with PNG fallback (MathML can be enabled via browser plugin): Invalid response ("Math extension cannot connect to Restbase.") from server "https://wikimedia.org/api/rest_v1/":): {\displaystyle f^*(y)} . Instead, we choose the minimizer of (51) as the new point xn+1. The TOMLAB routine AppRowQR is used to update the QR decomposition.

Our experience so far with the RBF algorithm shows that for the second strategy (idea2), the minimum of (24) is very sensitive for the scaling of the box constraints. To overcome this problem we transform the search space to the unit hypercube. This algorithm improvement is necessary to avoid rank deficiency in the interpolation matrix for the train design problem.

In our implementation it is possible to restart the optimization with the final status of all parameters from the previous run.