From f62f20fe5b8d43dcd23286f1c1b92b25bd4c2278 Mon Sep 17 00:00:00 2001 From: Brandon Paul <86113916+bpaul4@users.noreply.github.com> Date: Thu, 25 Apr 2024 14:12:50 -0700 Subject: [PATCH] remove RIPE examples (#107) --- idaes_examples/archive/ripe/__init__.py | 0 idaes_examples/archive/ripe/clc.csv | 33 -- idaes_examples/archive/ripe/clc.py | 34 -- idaes_examples/archive/ripe/clc_nb_src.ipynb | 178 ---------- idaes_examples/archive/ripe/crac.py | 160 --------- idaes_examples/archive/ripe/cracsim.py | 165 --------- idaes_examples/archive/ripe/index.md | 1 - idaes_examples/archive/ripe/isoT.py | 94 ----- idaes_examples/archive/ripe/isotsim.py | 112 ------ .../ripe/ripe_isothermal_cstr_src.ipynb | 330 ------------------ idaes_examples/archive/ripe/sv.alm | 23 -- idaes_examples/archive/ripe/temp.alm | 23 -- idaes_examples/archive/ripe/temp.lst | 160 --------- idaes_examples/archive/ripe/temptrace.trc | 76 ---- idaes_examples/archive/ripe/tmpscratch | 57 --- 15 files changed, 1446 deletions(-) delete mode 100644 idaes_examples/archive/ripe/__init__.py delete mode 100644 idaes_examples/archive/ripe/clc.csv delete mode 100644 idaes_examples/archive/ripe/clc.py delete mode 100644 idaes_examples/archive/ripe/clc_nb_src.ipynb delete mode 100644 idaes_examples/archive/ripe/crac.py delete mode 100644 idaes_examples/archive/ripe/cracsim.py delete mode 100644 idaes_examples/archive/ripe/index.md delete mode 100644 idaes_examples/archive/ripe/isoT.py delete mode 100644 idaes_examples/archive/ripe/isotsim.py delete mode 100644 idaes_examples/archive/ripe/ripe_isothermal_cstr_src.ipynb delete mode 100644 idaes_examples/archive/ripe/sv.alm delete mode 100644 idaes_examples/archive/ripe/temp.alm delete mode 100644 idaes_examples/archive/ripe/temp.lst delete mode 100644 idaes_examples/archive/ripe/temptrace.trc delete mode 100644 idaes_examples/archive/ripe/tmpscratch diff --git a/idaes_examples/archive/ripe/__init__.py b/idaes_examples/archive/ripe/__init__.py deleted file mode 100644 index e69de29b..00000000 diff --git a/idaes_examples/archive/ripe/clc.csv b/idaes_examples/archive/ripe/clc.csv deleted file mode 100644 index de3debbe..00000000 --- a/idaes_examples/archive/ripe/clc.csv +++ /dev/null @@ -1,33 +0,0 @@ -0.079111706,0.024202272 -0.128812507,0.064406608 -0.178362619,0.098030835 -0.224310337,0.13410538 -0.258410748,0.164062818 -0.304140207,0.189085218 -0.347046853,0.221691581 -0.384646869,0.244710317 -0.436366916,0.273685428 -0.489249009,0.303155575 -0.506703599,0.323913195 -0.551429918,0.342154371 -0.607150778,0.372149481 -0.652444747,0.398337777 -0.70285924,0.422371936 -0.754709809,0.449946271 -0.806508955,0.475275176 -0.860822469,0.503894911 -0.917264769,0.527161 -0.967346721,0.551238705 -1.028341715,0.57668451 -1.082502966,0.598655449 -1.136646025,0.619831959 -1.19078226,0.640710558 -1.24480786,0.656758033 -1.298853812,0.673694276 -1.35289624,0.690476598 -1.40652671,0.689270058 -1.460354801,0.696693008 -1.512777561,0.703608801 -1.567937074,0.708311539 -1.62164293,0.710396917 -1.650910985,0.710396917 diff --git a/idaes_examples/archive/ripe/clc.py b/idaes_examples/archive/ripe/clc.py deleted file mode 100644 index 95a9dbcd..00000000 --- a/idaes_examples/archive/ripe/clc.py +++ /dev/null @@ -1,34 +0,0 @@ -################################################################################# -# The Institute for the Design of Advanced Energy Systems Integrated Platform -# Framework (IDAES IP) was produced under the DOE Institute for the -# Design of Advanced Energy Systems (IDAES), and is copyright (c) 2018-2022 -# by the software owners: The Regents of the University of California, through -# Lawrence Berkeley National Laboratory, National Technology & Engineering -# Solutions of Sandia, LLC, Carnegie Mellon University, West Virginia University -# Research Corporation, et al. All rights reserved. -# -# Please see the files COPYRIGHT.md and LICENSE.md for full copyright and -# license information. -################################################################################# -from idaes.surrogate import ripe -import numpy as np -from idaes.surrogate.ripe import mechs as mechs - -def main(): - spec = ['X'] - # Import data from csv - data = np.genfromtxt('clc.csv', delimiter=',') - t = data[:,0] - xdata = data[:,1] - stoich = [1] - - # User pre-defined clc rate forms found in RIPE - # mechs = ripe.clcforms - clc_mechs = [mechs.powerlawp5, mechs.powerlaw2, mechs.powerlaw3, mechs.powerlaw4, mechs.avrami2, mechs.avrami3, mechs.avrami4, mechs.avrami5, mechs.randomnuc, mechs.ptompkins, mechs.jander, mechs.antijander, mechs.valensi, mechs.parabolic, mechs.gb3d, mechs.zlt, mechs.grain] - - # Identify optimal kinetic mechanism - results = ripe.ripemodel(xdata,stoichiometry=stoich,mechanisms=clc_mechs,time=t) - - -if __name__ == "__main__": - main() diff --git a/idaes_examples/archive/ripe/clc_nb_src.ipynb b/idaes_examples/archive/ripe/clc_nb_src.ipynb deleted file mode 100644 index f2f4f810..00000000 --- a/idaes_examples/archive/ripe/clc_nb_src.ipynb +++ /dev/null @@ -1,178 +0,0 @@ -{ - "cells": [ - { - "cell_type": "code", - "execution_count": null, - "id": "36c45c51", - "metadata": { - "tags": [ - "header", - "hide-cell" - ] - }, - "outputs": [], - "source": [ - "###############################################################################\n", - "# The Institute for the Design of Advanced Energy Systems Integrated Platform\n", - "# Framework (IDAES IP) was produced under the DOE Institute for the\n", - "# Design of Advanced Energy Systems (IDAES), and is copyright (c) 2018-2022\n", - "# by the software owners: The Regents of the University of California, through\n", - "# Lawrence Berkeley National Laboratory, National Technology & Engineering\n", - "# Solutions of Sandia, LLC, Carnegie Mellon University, West Virginia University\n", - "# Research Corporation, et al. All rights reserved.\n", - "#\n", - "# Please see the files COPYRIGHT.md and LICENSE.md for full copyright and\n", - "# license information.\n", - "###############################################################################" - ] - }, - { - "cell_type": "markdown", - "metadata": {}, - "source": [ - "Example from:\n", - "\n", - "Wilson, Zachary T., and Nikolaos V. Sahinidis. \"Automated learning of chemical reaction networks.\" Computers & Chemical Engineering 127 (2019): 88-98.\n", - "https://doi.org/10.1016/j.compchemeng.2019.05.020\n", - "\n", - "Case 2: Dynamic Chemical Looping Combusion Reactor\n", - "\n", - "This is an example of a CLC reactor. The kinetic reaction rates encapsulate solid-gas reactions. The kinetic rate laws for this example are semi-physical or empirical to provide insights on the underlying physical mechanisms.\n", - "\n", - "The rate laws are often expressed in terms similar to\n", - "\n", - "$ \\frac{dX}{dT} = kA(X)g(F) $\n", - "\n", - "where $ A(X) $ is a mechanism-dependent activity term, and the function $ g(F) $ is a parametric function of processss conditions, typically in this case the partial pressure of methane used as a fuel. \n" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "# Imports and data\n", - "\n", - "from idaes.apps import ripe\n", - "import numpy as np\n", - "from idaes.apps.ripe import mechs as mechs\n", - "\n", - "\n", - "np.random.seed(20)\n", - "\n", - "# Import data from csv\n", - "data = np.genfromtxt(\"clc.csv\", delimiter=\",\")\n", - "t = data[:, 0]\n", - "xdata = data[:, 1]\n", - "\n", - "# Stoichiometry\n", - "# One species\n", - "stoich = [1]" - ] - }, - { - "cell_type": "markdown", - "metadata": {}, - "source": [ - "We are going to use empirical pre-defined functions from RIPE, defined in the idaes.surrogate.ripe.mechs. The mechanisms depend on only one species for these pre-defined rate forms.\n", - "\n", - "Rate Equation | $ A(x) $\n", - ":--- | :--- \n", - "Random Nucleation | $ 1-x $ \n", - "Power law $n = 2/3, 1.5, 2, 3, 4 $ | $ nx^{(n-1/n)} $\n", - "Avrami-Erofeev $ n = 0.5, 1.5, 2, 3, 4$ | $ n(1-x)(-log(1-x))^{(n-1/n)} $\n", - "Prout Tompkins | $ x(x-1) $\n", - "Jander | $ 3(1-x)^{1/3} (1/(1+x)^{((-1/3)-1)}) $\n", - "Antijander | $ 3/2(1-x)^{(2/3)}(1/(1+x)^{((-1/3)-1)}) $\n", - "Valensi | $ 1/(-log(1-x)) $\n", - "Parabolic | $ 1/2x $\n", - "Ginstling-Brountstein diffusion-3d | $ (3/2)(1-x)^{(4/3)}/((1-x)^{(-1/3)}-1) $\n", - "Zhuralev-Leshokin-Tempelman | $ (3/2)/((1-x)^{(-1/3)}-1) $\n", - "Grain model | $ (1-x)^{(2/3)} $\n", - "\n", - "\n", - "\n" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "# User pre-defined clc rate forms found in RIPE\n", - "# mechs = ripe.clcforms\n", - "clc_mechs = [\n", - " mechs.randomnuc,\n", - " mechs.powerlawp5,\n", - " mechs.powerlaw2,\n", - " mechs.powerlaw3,\n", - " mechs.powerlaw4,\n", - " mechs.avrami2,\n", - " mechs.avrami3,\n", - " mechs.avrami4,\n", - " mechs.avrami5,\n", - " mechs.ptompkins,\n", - " mechs.jander,\n", - " mechs.antijander,\n", - " mechs.valensi,\n", - " mechs.parabolic,\n", - " mechs.gb3d,\n", - " mechs.zlt,\n", - " mechs.grain,\n", - "]" - ] - }, - { - "cell_type": "markdown", - "metadata": {}, - "source": [ - "All that is left is to run the ripe modeler:" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "# Identify optimal kinetic mechanism\n", - "results = ripe.ripemodel(xdata, stoichiometry=stoich, mechanisms=clc_mechs, time=t)" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [] - } - ], - "metadata": { - "idaes": { - "skip": [ - "test" - ] - }, - "kernelspec": { - "display_name": "Python 3", - "language": "python", - "name": "python3" - }, - "language_info": { - "codemirror_mode": { - "name": "ipython", - "version": 3 - }, - "file_extension": ".py", - "mimetype": "text/x-python", - "name": "python", - "nbconvert_exporter": "python", - "pygments_lexer": "ipython3", - "version": "3.7.6" - } - }, - "nbformat": 4, - "nbformat_minor": 4 -} diff --git a/idaes_examples/archive/ripe/crac.py b/idaes_examples/archive/ripe/crac.py deleted file mode 100644 index 91aad9b7..00000000 --- a/idaes_examples/archive/ripe/crac.py +++ /dev/null @@ -1,160 +0,0 @@ -################################################################################# -# The Institute for the Design of Advanced Energy Systems Integrated Platform -# Framework (IDAES IP) was produced under the DOE Institute for the -# Design of Advanced Energy Systems (IDAES), and is copyright (c) 2018-2022 -# by the software owners: The Regents of the University of California, through -# Lawrence Berkeley National Laboratory, National Technology & Engineering -# Solutions of Sandia, LLC, Carnegie Mellon University, West Virginia University -# Research Corporation, et al. All rights reserved. -# -# Please see the files COPYRIGHT.md and LICENSE.md for full copyright and -# license information. -################################################################################# -# This file contains an example application of the RIPE software -# The goal is to identify the reaction kinetics present in a reactor -# where ethylbenzene is converted to styrene, with a number of side products -# -# Initial training sets provided through random or space-filling sampling -# result in incorrect model identification -# Error maximization sampling can be used to refine the model - -import pyomo.environ as pyo -from idaes.surrogate import ripe -import numpy as np -import random -import cracsim - -np.random.seed(100) - -# Define kinetic mechanisms, adsorption parameters must be known a-priori -kco = 35 -kst = 1.5 - -def main(): - Tr = 750.0 - # Experimental variance is known in this problem, - # it can be estimated if not provided - noise = 0.05 - # ndata = 10 in publication example - ndata = 30 - ns = 9 - # Define temperature bounds - Tlo = 500 - Tup = 1000 - # Define range of inlet concentrations - lb = [0,0,0,0,0,1,0,0,1] - ub = [3]*ns - - gc = .008314 - - Temp = np.linspace(Tlo,Tup,ndata) - # Initialize concentration data - - # Inlet concentrations are fixed in publication example - # cdata0 = [[.5,0,0,0,0,4.5,0,0,4.5]]*ndata - cdata0=np.zeros([ndata,ns]) - for i in range(ndata): - for j in range(ns): - cdata0[i,j] = random.uniform(lb[j],ub[j]) - - - # Calculate steady-state concentration values from simulator cracsim.py - cdata = cracsim.sim(np.hstack((cdata0, np.expand_dims(Temp, axis=1)))) - - # In this example, we know the true stoichiometries. Lets define them first for clarity - t_stoich = [[-1,1,0,0,0,0,1,0,0],[-1,0,1,1,0,0,0,0,0],[0,0,0,-1,2,0,-2,0,0],[0,0,0,0,-1,-2,4,1,0]] - # Additional considered stoichiometries are defined - a_stoich = [[-1,0,0,0,0,-16,21,8,0],[-1,0,0,4,0,0,-3,0,0],[0,0,0,-1,0,-4,6,2,0],[-1,0,1,0,2,0,-2,0,0]] - # Index 0-3 are the true reactions, 4-7 are considered reactions - stoichs = t_stoich+a_stoich - - # Define kinetic mechanisms, adsorption parameters must be known a-priori - kco = 35 - kst = 1.5 - - # Mechanisms can be defined for each stoichiometry using a list-of-list - mechs = [[[0,1,3,4,7],eb_dep],[[0],[t_st_prod,cat_st_prod_t1]],[[0,1],cat_ben_prod_t2],[[2,3],meth_prod_t3],[[2,3],ch4_to_co_t4],[[2,3,4,5,6,7],[ma_g,ma_h]]] - - # Experimental variance is known in this case - sigma = np.multiply(noise**2,cdata) - - results = ripe.ripemodel(cdata,stoich = stoichs,mechanisms=mechs,x0=cdata0,temp=Temp,sigma=sigma,tref=Tr) - - -def keq(*x): - a,b,c,d,f,g,h,i,j,T = x - temp = 0.1 + 300/T - return pyo.exp(temp) - -# These mechanisms are present in the simulation -def cat_st_prod_t1(*x): - a,b,c,d,f,g,h,i,j,Temp = x - return (a - (b * h) / keq(*x)) * (1/((1+kst*b)*(1+kco*i))) - -def cat_ben_prod_t2(*x): - # Mechanism for EB > B + C2H4 - a,b,c,d,f,g,h,i,j,Temp = x - return a / (1+kco*i) - -def meth_prod_t3(*x): - # Mechanism for C2H4+4H2O > 2CO2+6H - a,b,c,d,f,g,h,i,j,Temp = x - return d * h - -def ch4_to_co_t4(*x): - a,b,c,d,f,g,h,i,j,Temp = x - #mechanism for CH4+2H2O > CO2+4H2 - return f * g - -# Additional mechanisms are specified for the true stoichiometries and additional stoichs -def eb_dep(*x): - a,b,c,d,f,g,h,i,j,Temp = x - return a - -def t_st_prod(*x): - a,b,c,d,f,g,h,i,j,Temp = x - return (a - (b * h) / keq(*x)) - -def ma_h(*x): - a,b,c,d,f,g,h,i,j,Temp = x - return h - -def ma_g(*x): - a,b,c,d,f,g,h,i,j,Temp = x - return g - - -# The following section of code can be un-commented in order to continue sampling data until an accurate model is obtained -# note that this is considerably more computationally expensive -''' -#Append T bounds for ems variables -lb.append(Tlo) -ub.append(Tup) - -# Call RIPE ems in order to identify the next best sample point -[new_points, err] = ripe.ems(results,cracsim.sim,lb,ub,ns,x=cdata,x0=cdata0,Temp=Temp,Tref=Tr)#,frac=fracfun) -new_res = cracsim.sim(new_points) -ite = 0 -data = cdata -data0 = cdata0 -tdata = Temp.tolist() -# print 'maximum allowable tolerances : ', [2*noise*s for s in new_res] -while any(err > [2*noise*s for s in new_res] ): -# print 'Which concentration : ', err > [noise*s for s in new_res] - data = np.vstack((data,new_res)) - data0 = np.vstack((data0,new_points[:-1])) - tdata.append(new_points[-1]) - results = {} - ite+=1 - sigma = np.multiply(noise**2,np.array(data)) - results = ripe.ripemodel(data,stoich = stoichs,mechanisms=mechs,x0=data0,sigma=sigma,temp=tdata,tref=Tr, hide_output=True) - [new_points, err] = ripe.ems(results,cracsim.sim,lb,ub,10,x=data,x0=data0,temp=tdata,tref=Tr) - new_res = cracsim.sim(new_points) -# print 'currently at '+str(len(data))+' data points' -# print 'proposed new conc : ', new_res -# print 'maximum allowable tolerances : ', [noise*s for s in new_res] -''' - - -if __name__ == "__main__": - main() diff --git a/idaes_examples/archive/ripe/cracsim.py b/idaes_examples/archive/ripe/cracsim.py deleted file mode 100644 index def81369..00000000 --- a/idaes_examples/archive/ripe/cracsim.py +++ /dev/null @@ -1,165 +0,0 @@ -################################################################################# -# The Institute for the Design of Advanced Energy Systems Integrated Platform -# Framework (IDAES IP) was produced under the DOE Institute for the -# Design of Advanced Energy Systems (IDAES), and is copyright (c) 2018-2022 -# by the software owners: The Regents of the University of California, through -# Lawrence Berkeley National Laboratory, National Technology & Engineering -# Solutions of Sandia, LLC, Carnegie Mellon University, West Virginia University -# Research Corporation, et al. All rights reserved. -# -# Please see the files COPYRIGHT.md and LICENSE.md for full copyright and -# license information. -################################################################################# -# This file contains a reactor simulator built in pyomo -# The simulator emulates behavior observed in the production of -# Styrene from ethylbenzene - -import numpy as np -import pyomo.environ as pyo - -# define fractional variance of noise, SNR = 1 / noise -noise = 0.05 - -# Reference temperature defined -Tr = 750.0 -# Kinetic parameters are hard coded in the form [[k1,k2...],[E1,E2,...]] -kinetic_params = [[250,220,38,25],[115,131,55,75]] - - -def sim(data): - import numpy as np - # Enable 1/2d calls - # Ensure that data sizes and shapes are consistent - try: - x0 = data[:,:9] - Temp = data[:,9] - except: - x0 = data[:9] - Temp = data[9] - params = kinetic_params - dshape = np.shape(x0) - if len(dshape) == 1: - x0 = np.expand_dims(x0, axis=-1) - x0 = np.ndarray.transpose(x0) - dshape = np.shape(x0) - npc = dshape[0] - ns = dshape[1] - # Define the reactor simulation in pyomo - def pyomosim(data): - # Define rate parameters - kco = 35 - kst = 1.5 - sparam = 1.0 - flow = 1.0 - vol = 1.0 - gc = .008314 - # Define kinetic rate parameters - k = params[0] - E = params[1] - # define UB for concentration - #nound_ub = 20 - # pyomo solver options - opt = pyo.SolverFactory('baron') - cracmodel = pyo.ConcreteModel() - ca0,cb0,cc0,cd0,cf0,cg0,ch0,ci0,cj0,T = [float(v) for v in data] - - bound_ub = 100.0 - # Define cracmodel variables - # A = Eb , B = St , C = Bz , D = Et, E = Tl, F = Me, G = Water, H = H2 I = CO2, J = N2 - cracmodel.a = pyo.Var(domain = pyo.NonNegativeReals, bounds = (0,bound_ub), initialize = ca0) - cracmodel.b = pyo.Var(domain = pyo.NonNegativeReals, bounds = (0,bound_ub), initialize = cb0) - cracmodel.c = pyo.Var(domain = pyo.NonNegativeReals, bounds = (0,bound_ub), initialize = cc0) - cracmodel.d = pyo.Var(domain = pyo.NonNegativeReals, bounds = (0,bound_ub), initialize = cd0) - cracmodel.f = pyo.Var(domain = pyo.NonNegativeReals, bounds = (0,bound_ub), initialize = cf0) - cracmodel.g = pyo.Var(domain = pyo.NonNegativeReals, bounds = (0,bound_ub), initialize = cg0) - cracmodel.h = pyo.Var(domain = pyo.NonNegativeReals, bounds = (0,bound_ub), initialize = ch0) - cracmodel.i = pyo.Var(domain = pyo.NonNegativeReals, bounds = (0,bound_ub), initialize = ci0) - cracmodel.j = pyo.Var(domain = pyo.NonNegativeReals, bounds = (0,bound_ub), initialize = cj0) - cracmodel.r1 = pyo.Var(domain = pyo.Reals) - cracmodel.r2 = pyo.Var(domain = pyo.Reals) - cracmodel.r4 = pyo.Var(domain = pyo.Reals) - cracmodel.r5 = pyo.Var(domain = pyo.Reals) - - def keq(T): - return pyo.exp(0.1 + (300 / T)) -# return pyo.exp(-1.0*(122700-126.3*T-0.002194*T**2)/(gc*T)) * sparam - # define reaction rate variable - - def fr1(cracmodel): - # A <> B + H - return cracmodel.r1 == k[0] * pyo.exp(-(E[0]/(gc))*((1/T)-(1/Tr))) * (cracmodel.a - (cracmodel.b * cracmodel.h)/keq(T)) * (1.0/((1+kst*cracmodel.b)*(1+kco*cracmodel.i))) - def fr2(cracmodel): - # A > C + D - return cracmodel.r2 == k[1] * pyo.exp(-(E[1]/(gc))*((1/T)-(1/Tr))) * cracmodel.a * (1.0/(1+kco*cracmodel.i)) - - def fr4(cracmodel): - # D + 2H > 2F - return cracmodel.r4 == k[2] * pyo.exp(-(E[2]/(gc))*((1/T)-(1/Tr))) * cracmodel.d * cracmodel.h - def fr5(cracmodel): - # F+G > I + 4H - return cracmodel.r5 == k[3] * pyo.exp(-(E[3]/(gc))*((1/T)-(1/Tr))) * cracmodel.f * cracmodel.g - - cracmodel.er1 = pyo.Constraint( rule = fr1) - cracmodel.er2 = pyo.Constraint( rule = fr2) - cracmodel.er4 = pyo.Constraint( rule = fr4) - cracmodel.er5 = pyo.Constraint( rule = fr5) - cracmodel.sets = pyo.RangeSet(9) - cracmodel.dum = pyo.Var(cracmodel.sets, domain = pyo.Reals) - - def fra(cracmodel): # A - 1,2,3 - return cracmodel.dum[1] == ca0-cracmodel.a - cracmodel.r1 -cracmodel.r2 - def frb(cracmodel): # B - 1 - return cracmodel.dum[2] == cb0-cracmodel.b+cracmodel.r1 - def frc(cracmodel): # C - 2 - return cracmodel.dum[3] == cc0-cracmodel.c+cracmodel.r2 - def frd(cracmodel): # D - 2,4 - return cracmodel.dum[4] == cd0-cracmodel.d+cracmodel.r2-cracmodel.r4 - def frf(cracmodel): # F - 3,4,5 - return cracmodel.dum[5] == cf0-cracmodel.f+2*cracmodel.r4-cracmodel.r5 - def frg(cracmodel): # G - 5 - return cracmodel.dum[6] == cg0-cracmodel.g-2*cracmodel.r5 - def frh(cracmodel): # H - 1,3,4,5 - return cracmodel.dum[7] == ch0-cracmodel.h+cracmodel.r1-2*cracmodel.r4+4*cracmodel.r5 - def fri(cracmodel): # I - 5 - return cracmodel.dum[8] == ci0-cracmodel.i + cracmodel.r5 - def frj(cracmodel): # J - N2 is inert - return cracmodel.dum[9] == cj0-cracmodel.j - - cracmodel.era = pyo.Constraint( rule = fra) - cracmodel.erb = pyo.Constraint( rule = frb) - cracmodel.erc = pyo.Constraint( rule = frc) - cracmodel.erd = pyo.Constraint( rule = frd) - cracmodel.erf = pyo.Constraint( rule = frf) - cracmodel.erg = pyo.Constraint( rule = frg) - cracmodel.erh = pyo.Constraint( rule = frh) - cracmodel.eri = pyo.Constraint( rule = fri) - cracmodel.erj = pyo.Constraint( rule = frj) - - # minimize square of dummy variables to find steady-state concentrations - def objf(cracmodel): - return sum(cracmodel.dum[s]**2 for s in cracmodel.sets) - - cracmodel.OBJ = pyo.Objective(rule = objf) - results = opt.solve(cracmodel) - cracmodel.solutions.store_to(results) - klist = ['a','b','c','d','f','g','h','i','j'] - # Add noise of the specifiec SNR, noise has variance eps ~ N(0,noise*conc) - vn = [results.Solution.Variable[key]['Value']+np.random.normal(0,noise*results.Solution.Variable[key]['Value']) for key in klist] - return vn - - # Simulate over requested datapoints - # requested data may have 1 or more points - concentrations = [] - if npc != 1: - for i in range(npc): - try: - t2 = Temp[0][i] - except: - t2 = Temp[i] - conres = pyomosim(np.ndarray.tolist(x0[i,:])+[t2]) - - concentrations.append(conres) - else: - conres = pyomosim(data) - concentrations = conres - return concentrations diff --git a/idaes_examples/archive/ripe/index.md b/idaes_examples/archive/ripe/index.md deleted file mode 100644 index 99152f29..00000000 --- a/idaes_examples/archive/ripe/index.md +++ /dev/null @@ -1 +0,0 @@ -# RIPE \ No newline at end of file diff --git a/idaes_examples/archive/ripe/isoT.py b/idaes_examples/archive/ripe/isoT.py deleted file mode 100644 index 9ac1b95f..00000000 --- a/idaes_examples/archive/ripe/isoT.py +++ /dev/null @@ -1,94 +0,0 @@ -################################################################################# -# The Institute for the Design of Advanced Energy Systems Integrated Platform -# Framework (IDAES IP) was produced under the DOE Institute for the -# Design of Advanced Energy Systems (IDAES), and is copyright (c) 2018-2022 -# by the software owners: The Regents of the University of California, through -# Lawrence Berkeley National Laboratory, National Technology & Engineering -# Solutions of Sandia, LLC, Carnegie Mellon University, West Virginia University -# Research Corporation, et al. All rights reserved. -# -# Please see the files COPYRIGHT.md and LICENSE.md for full copyright and -# license information. -################################################################################# -import pyomo.environ as pyo -from idaes.surrogate import ripe -import numpy as np -import random -import isotsim - -np.random.seed(20) - - -def main(): - - #ndata = 100 - noise = 0.1 - ns = 5 - lb_conc = [0,0,0,0,0] - ub_conc = [10,10,0,0,0] - - - # Initialize concentration arrays - - # initial concentrations - only 2 data points at bounds - cdata0 = [[1,1,0,0,0],[10,10,0,0,0]] - cdata = isotsim.sim(cdata0) - nd = len(cdata0) - - # Considered reaction stoichiometries - stoich = [[-1,-1,1,0,0] ,[0,-1,-1,1,0],[-1,0,0,-1,1],[-1,-2,0,1,0] ,[-2,-2,0,0,1],[-1,-1,-1,0,1],[-2,-1,1,-1,1]] - - # IRIPE internal mass action kinetics are specified - rxn_mechs = [['all','massact']] - - # Use expected variance - estimated from data if not provided - sigma = np.multiply(noise**2,np.array(cdata)) - - # Call to RIPE - results = ripe.ripemodel(cdata,stoich = stoich,mechanisms=rxn_mechs,x0=cdata0,hide_output=False,sigma=sigma,deltaterm=0,expand_output=True) - - # Adaptive experimental design using error maximization sampling - [new_points, err] = ripe.ems(results, isotsim.sim, lb_conc, ub_conc, 5, x=cdata, x0=cdata0) - - # Implement EMS as described in the RIPE publication - new_res = isotsim.sim(new_points)[0] - ite = 0 - # print 'maximum allowable tolerances : ', [noise*s for s in new_res] - while any(err > [2*noise*s for s in new_res] ): - # print 'Which concentrations violate error (True=violation) : ', err > [noise*s for s in new_res] - results = {} - ite+=1 - # Data updated explicitly so RBFopt subroutines produce consistent results - new_cdata0 = np.zeros([nd+ite,ns]) - new_cdata = np.zeros([nd+ite,ns]) - new_cdata0[:-1][:] = cdata0[:][:] - new_cdata[:-1][:] = cdata[:][:] - new_cdata0[-1][:] = new_points[:] - res = isotsim.sim(new_points)[0] - for j in range(len(res)): - new_cdata[-1][j] = res[j] - - #Update weight parameters - sigma = np.multiply(noise**2,np.array(new_cdata)) - - # Build updated RIPE model - results = ripe.ripemodel(new_cdata,stoich = stoich,mechanisms=rxn_mechs,x0=new_cdata0,sigma=sigma,expand_output=True) - - # Another call to EMS - [new_points, err] = ripe.ems(results, isotsim.sim, lb_conc, ub_conc, 5, x=cdata, x0=cdata0) - - # Update results - new_res = isotsim.sim(new_points)[0] - cdata0 = new_cdata0 - cdata = new_cdata - - # Final call to RIPE to get concise output - results = ripe.ripemodel(cdata,stoich = stoich,mechanisms=rxn_mechs,x0=cdata0,sigma=sigma,expand_output=False) - #print results - - -if __name__ == "__main__": - main() - - - diff --git a/idaes_examples/archive/ripe/isotsim.py b/idaes_examples/archive/ripe/isotsim.py deleted file mode 100644 index 05b13e78..00000000 --- a/idaes_examples/archive/ripe/isotsim.py +++ /dev/null @@ -1,112 +0,0 @@ -################################################################################# -# The Institute for the Design of Advanced Energy Systems Integrated Platform -# Framework (IDAES IP) was produced under the DOE Institute for the -# Design of Advanced Energy Systems (IDAES), and is copyright (c) 2018-2022 -# by the software owners: The Regents of the University of California, through -# Lawrence Berkeley National Laboratory, National Technology & Engineering -# Solutions of Sandia, LLC, Carnegie Mellon University, West Virginia University -# Research Corporation, et al. All rights reserved. -# -# Please see the files COPYRIGHT.md and LICENSE.md for full copyright and -# license information. -################################################################################# -import numpy as np -noise = 0.1 - - -def sim(data): - x0 = data - params = [1.5,2.1,0.9] - #pyomo simulator for cracking example - import numpy as np - import pyomo.environ as pyo - - dshape = np.shape(x0) - - if len(dshape) == 1: - x0 = np.expand_dims(x0, axis=-1) - x0 = np.ndarray.transpose(x0) - dshape = np.shape(x0) - npc = dshape[0] - ns = dshape[1] - if dshape[0] == 1: - xo = [x0]*npc - - def pyomosim(x0): - # Define rate parameters - flow = 1.0 - vol = 1.0 - gc = 8.314 - # Define kinetic rate parameters - k = params - a0,b0,c0,d0,e0 = np.array(x0).T.tolist() - opt = pyo.SolverFactory('baron') - model = pyo.ConcreteModel() -# bound_ub = 100 - # Define model variables - model.a = pyo.Var(domain = pyo.NonNegativeReals)#, bounds = (0.0,bound_ub)) - model.b = pyo.Var(domain = pyo.NonNegativeReals)#, bounds = (0.0,bound_ub)) - model.c = pyo.Var(domain = pyo.NonNegativeReals)#, bounds = (0.0,bound_ub)) - model.d = pyo.Var(domain = pyo.NonNegativeReals)#, bounds = (0.0,bound_ub)) - model.e = pyo.Var(domain = pyo.NonNegativeReals)#, bounds = (0.0,bound_ub)) - model.dset = pyo.RangeSet(5) - model.dum = pyo.Var(model.dset) - - model.r1 = pyo.Var(domain = pyo.Reals) - model.r2 = pyo.Var(domain = pyo.Reals) - model.r3 = pyo.Var(domain = pyo.Reals) - - def fr1(model): - return model.r1 == k[0] * model.a * model.b - def fr2(model): - return model.r2 == k[1] * model.b * model.c - def fr3(model): - return model.r3 == k[2] * model.a * model.d - - model.er1 = pyo.Constraint( rule = fr1) - model.er2 = pyo.Constraint( rule = fr2) - model.er3 = pyo.Constraint( rule = fr3) - - num = 1.0 - def fra(model): - return num * model.dum[1] == (flow/vol)*(a0-model.a ) - model.r1 -model.r3 - def frb(model): - return num * model.dum[2] == (flow/vol)*(b0-model.b ) - model.r1 - model.r2 - def frc(model): - return num * model.dum[3] == (flow/vol)*(c0-model.c) + model.r1 - model.r2 - def frd(model): - return num * model.dum[4] == (flow/vol)*(d0-model.d) + model.r2 - model.r3 - def fre(model): - return num * model.dum[5] == (flow/vol)*(e0-model.e) + model.r3 - - model.era = pyo.Constraint(rule=fra) - model.erb = pyo.Constraint( rule = frb) - model.erc = pyo.Constraint( rule = frc) - model.erd = pyo.Constraint( rule = frd) - model.ere = pyo.Constraint( rule = fre) - - def objf(model): - return sum([ model.dum[i]**2 for i in model.dset]) - - model.OBJ = pyo.Objective(rule = objf) - - results = opt.solve(model, tee=False) - model.solutions.store_to(results) - # Note: noise is not truly normally distributed as concentration values cannot be negative -# print 'debug this : ', results.Solution.Variable['a']['Value'],np.random.normal(0,noise*results.Solution.Variable['a']['Value']),np.argmax([0.0,results.Solution.Variable['a']['Value']+np.random.normal(0,noise*results.Solution.Variable['a']['Value'])]) - v = [results.Solution.Variable[key]['Value'] for key in ['a','b','c','d','e']] - vn = [results.Solution.Variable[key]['Value']+np.random.normal(0,noise*results.Solution.Variable[key]['Value']) for key in ['a','b','c','d','e']] - tsum = 0 - for i in range(5): - if vn[i] < 0: - vn[i] = v[i] - tsum+= 1 -# print 'total number of zeros : ', tsum - return vn - - # Simulate over requested datapoints - concentrations = [] - for i in range(npc): - conres = pyomosim(x0[i]) - concentrations.append(conres) - return concentrations diff --git a/idaes_examples/archive/ripe/ripe_isothermal_cstr_src.ipynb b/idaes_examples/archive/ripe/ripe_isothermal_cstr_src.ipynb deleted file mode 100644 index 66222900..00000000 --- a/idaes_examples/archive/ripe/ripe_isothermal_cstr_src.ipynb +++ /dev/null @@ -1,330 +0,0 @@ -{ - "cells": [ - { - "cell_type": "code", - "execution_count": null, - "id": "13a2fb8e", - "metadata": { - "tags": [ - "header", - "hide-cell" - ] - }, - "outputs": [], - "source": [ - "###############################################################################\n", - "# The Institute for the Design of Advanced Energy Systems Integrated Platform\n", - "# Framework (IDAES IP) was produced under the DOE Institute for the\n", - "# Design of Advanced Energy Systems (IDAES), and is copyright (c) 2018-2022\n", - "# by the software owners: The Regents of the University of California, through\n", - "# Lawrence Berkeley National Laboratory, National Technology & Engineering\n", - "# Solutions of Sandia, LLC, Carnegie Mellon University, West Virginia University\n", - "# Research Corporation, et al. All rights reserved.\n", - "#\n", - "# Please see the files COPYRIGHT.md and LICENSE.md for full copyright and\n", - "# license information.\n", - "###############################################################################" - ] - }, - { - "cell_type": "markdown", - "metadata": {}, - "source": [ - "Example from:\n", - "\n", - "Wilson, Zachary T., and Nikolaos V. Sahinidis. \"Automated learning of chemical reaction networks.\" Computers & Chemical Engineering 127 (2019): 88-98.\n", - "https://doi.org/10.1016/j.compchemeng.2019.05.020\n", - "\n", - "*Case 1: Isothermal CSTR*\n", - "\n", - "For isothermal CSTRs across a known range of feed concentrations, $C_s^l \\leq C_s^0 \\leq C_s^u$, s $\\in$ F. \n", - "\n", - "The simulated reaction networks id defined below, where $k_1^{true} = 1.5$, $k_2^{true} = 2.1$, and $k_3^{true} = 0.9$ with a residence time of $\\tau = 1$ is used for the reactor. \n", - "\n", - "\n", - "$A + B \\rightarrow C \\quad \\{{k_1^{true}}\\}$ \n", - "\n", - "$B + C \\rightarrow D \\quad \\{{k_2^{true}}\\}$\n", - "\n", - "$A + D \\rightarrow E \\quad \\{{k_3^{true}}\\}$\n", - "\n", - "Initial concentrations are specificed for species $F = {A,B}$ over the range $0 \\leq C_s^0 \\leq 10$, $s\\in F$." - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "# Imports\n", - "\n", - "import pyomo.environ as pyo\n", - "from idaes.apps import ripe\n", - "import numpy as np\n", - "import random\n", - "import isotsim\n", - "\n", - "np.random.seed(20)\n", - "\n", - "# Setup the problem\n", - "noise = 0.1\n", - "ns = 5 # number of species\n", - "lb_conc = [0, 0, 0, 0, 0]\n", - "ub_conc = [10, 10, 0, 0, 0]\n", - "\n", - "# initial concentrations - only 2 data points\n", - "cdata0 = [[1, 1, 0, 0, 0], [10, 10, 0, 0, 0]]\n", - "cdata = isotsim.sim(cdata0)\n", - "nd = len(cdata0) # number of data points\n", - "\n", - "# Expected variance based off the noise in the data\n", - "sigma = np.multiply(noise**2, np.array(cdata))" - ] - }, - { - "cell_type": "markdown", - "metadata": {}, - "source": [ - "The postulated set reaction stoichiometries is defined as:\n", - "\n", - "$ A + B \\rightarrow C $\n", - "\n", - "$ B + C \\rightarrow D $\n", - "\n", - "$ A + D \\rightarrow E $\n", - "\n", - "$ A + 2B \\rightarrow D $\n", - "\n", - "$ 2A + 2B \\rightarrow E $\n", - "\n", - "$ A + B + C \\rightarrow E $\n", - "\n", - "$ 2A + B + D \\rightarrow C + E$\n", - "\n", - "$ C + D \\rightarrow E + A $\n", - "\n", - "$ 3A + 3B \\rightarrow C + E $\n", - "\n", - "$ 3A + 4B \\rightarrow D + E $\n", - "\n", - "$ 2A + 3B \\rightarrow C + D $\n", - "\n", - "$ 4A + 5B \\rightarrow C + D + E $" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "# considered reaction stoichiometries\n", - "# A B C D E\n", - "stoich = [\n", - " [-1, -1, 1, 0, 0],\n", - " [0, -1, -1, 1, 0],\n", - " [-1, 0, 0, -1, 1],\n", - " [-1, -2, 0, 1, 0],\n", - " [-2, -2, 0, 0, 1],\n", - " [-1, -1, -1, 0, 1],\n", - " [-2, -1, 1, -1, 1],\n", - " [1, 0, -1, -1, 1],\n", - " [-3, -3, 1, 0, 1],\n", - " [-3, -4, 0, 1, 1],\n", - " [-2, -3, 1, 1, 0],\n", - " [-4, -5, 1, 1, 1],\n", - "]" - ] - }, - { - "cell_type": "markdown", - "metadata": {}, - "source": [ - "We have the initial conditions and possible stoichiometries to consider, but we still need the kinetics reaction mechanisms. Reaction mechanisms require a stoichiometry and kinetic model. In this case, we will be using mass action kinetics for all the stoichiometries available, which is built into RIPE." - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "# IRIPE internal mass action kinetics are specified\n", - "rxn_mechs = [[\"all\", \"massact\"]]" - ] - }, - { - "cell_type": "markdown", - "metadata": {}, - "source": [ - "Now we are ready to run the RIPE model builder:" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "results = ripe.ripemodel(\n", - " cdata,\n", - " stoich=stoich,\n", - " mechanisms=rxn_mechs,\n", - " x0=cdata0,\n", - " hide_output=False,\n", - " sigma=sigma,\n", - " deltaterm=0,\n", - " expand_output=True,\n", - ")" - ] - }, - { - "cell_type": "markdown", - "metadata": {}, - "source": [ - "Based on the number of data points, the best model chosen is only one reaction.\n", - "\n", - "$ 4A + 5B \\rightarrow C + D + E $\n", - "\n", - "So similar to how ALAMO iterates between developing a model and adding additional points with error maximization, RIPE provides methods to do the same." - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "# Adaptive experimental design using error maximization sampling\n", - "[new_points, err] = ripe.ems(\n", - " results, isotsim.sim, lb_conc, ub_conc, 5, x=cdata, x0=cdata0 # number of species\n", - ")\n", - "print(\"New Point\", new_points)\n", - "print(\"Error\", err)\n", - "\n", - "# Implement EMS as described in the RIPE publication\n", - "new_res = isotsim.sim(new_points)[0]\n", - "print(\"New Result\", new_res)" - ] - }, - { - "cell_type": "markdown", - "metadata": {}, - "source": [ - "Running ripe.ems gives us additional points maximizing the error that we can use to develop a new model until our error tolerance is achieved. A common loop in using RIPE follows:" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "ite = 0\n", - "\n", - "while any(err > [2 * noise * s for s in new_res]):\n", - " print(\n", - " \"Which concentrations violate error (True=violation) : \",\n", - " err > [noise * s for s in new_res],\n", - " )\n", - " results = {}\n", - " ite += 1\n", - "\n", - " # Data updated explicitly\n", - " # so RBFopt subroutines produce consistent results\n", - "\n", - " new_cdata0 = np.zeros([nd + ite, ns])\n", - " new_cdata = np.zeros([nd + ite, ns])\n", - " new_cdata0[:-1][:] = cdata0[:][:]\n", - " new_cdata[:-1][:] = cdata[:][:]\n", - " new_cdata0[-1][:] = new_points[:]\n", - " res = isotsim.sim(new_points)[0]\n", - " for j in range(len(res)):\n", - " new_cdata[-1][j] = res[j]\n", - "\n", - " # Update weight parameters\n", - " sigma = np.multiply(noise**2, np.array(new_cdata))\n", - "\n", - " # Build updated RIPE model\n", - " results = ripe.ripemodel(\n", - " new_cdata,\n", - " stoich=stoich,\n", - " mechanisms=rxn_mechs,\n", - " x0=new_cdata0,\n", - " sigma=sigma,\n", - " expand_output=True,\n", - " )\n", - "\n", - " # Another call to EMS\n", - " [new_points, err] = ripe.ems(\n", - " results, isotsim.sim, lb_conc, ub_conc, 5, x=cdata, x0=cdata0\n", - " )\n", - "\n", - " # Update results\n", - " new_res = isotsim.sim(new_points)[0]\n", - " cdata0 = new_cdata0\n", - " cdata = new_cdata" - ] - }, - { - "cell_type": "markdown", - "metadata": {}, - "source": [ - "The results can vary, but RIPE can identify the simulated system of:\n", - "\n", - "$A + B \\rightarrow C \\quad \\{{k_1^{true}}\\}$ \n", - "\n", - "$B + C \\rightarrow D \\quad \\{{k_2^{true}}\\}$\n", - "\n", - "$A + D \\rightarrow E \\quad \\{{k_3^{true}}\\}$" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [ - "# Final call to RIPE to get concise output\n", - "results = ripe.ripemodel(\n", - " cdata,\n", - " stoich=stoich,\n", - " mechanisms=rxn_mechs,\n", - " x0=cdata0,\n", - " sigma=sigma,\n", - " expand_output=False,\n", - ")\n", - "print(results)" - ] - }, - { - "cell_type": "code", - "execution_count": null, - "metadata": {}, - "outputs": [], - "source": [] - } - ], - "metadata": { - "kernelspec": { - "display_name": "Python 3", - "language": "python", - "name": "python3" - }, - "language_info": { - "codemirror_mode": { - "name": "ipython", - "version": 3 - }, - "file_extension": ".py", - "mimetype": "text/x-python", - "name": "python", - "nbconvert_exporter": "python", - "pygments_lexer": "ipython3", - "version": "3.7.6" - } - }, - "nbformat": 4, - "nbformat_minor": 4 -} diff --git a/idaes_examples/archive/ripe/sv.alm b/idaes_examples/archive/ripe/sv.alm deleted file mode 100644 index 4832c0c6..00000000 --- a/idaes_examples/archive/ripe/sv.alm +++ /dev/null @@ -1,23 +0,0 @@ -linfcns 1 -funform 1 -trace 1 -tracefname temptrace.trc -solvemip 1 -ninputs 1 -noutputs 1 -xlabels st -modeler 1 -monomialpower 0.5 1 1.5 2 -logfcns 1 -expfcns 1 -constant 0 -xmin 0 -xmax 1.650910985 -cvxbic 1 -initialpoints 3 -ndata 3 -begin_data -1.512777561 0.703608801 -1.567937074 0.708311539 -1.62164293 0.710396917 -end_data diff --git a/idaes_examples/archive/ripe/temp.alm b/idaes_examples/archive/ripe/temp.alm deleted file mode 100644 index 4832c0c6..00000000 --- a/idaes_examples/archive/ripe/temp.alm +++ /dev/null @@ -1,23 +0,0 @@ -linfcns 1 -funform 1 -trace 1 -tracefname temptrace.trc -solvemip 1 -ninputs 1 -noutputs 1 -xlabels st -modeler 1 -monomialpower 0.5 1 1.5 2 -logfcns 1 -expfcns 1 -constant 0 -xmin 0 -xmax 1.650910985 -cvxbic 1 -initialpoints 3 -ndata 3 -begin_data -1.512777561 0.703608801 -1.567937074 0.708311539 -1.62164293 0.710396917 -end_data diff --git a/idaes_examples/archive/ripe/temp.lst b/idaes_examples/archive/ripe/temp.lst deleted file mode 100644 index 0f23cb5d..00000000 --- a/idaes_examples/archive/ripe/temp.lst +++ /dev/null @@ -1,160 +0,0 @@ - *************************************************************************** - ALAMO version 2022.10.7. Built: WIN-64 Fri Oct 7 21:02:38 EDT 2022 - -The options and data used in solving this problem are as follows: - -NINPUTS = 1 -NOUTPUTS = 1 -NTRANS = 0 -NCVF = 5 -NPENL = 100 -NDATA = 3 -NPREDATA = 0 -NSAMPLE = 0 -NVALDATA = 0 -NVALSAMPLE = 0 -NVALSETS = 0 -PRFREQ = 1 -INITIALPOINTS = 3 -SAMPLER = 1 -MODELER = 1 -INITIALIZER = 3 -BUILDER = 1 -ENUM1 = 16384 -ENUMALL = 0 -GREEDYBUILDER = T -NDGELS = 120 -SCREENER = 0 -SISMULT = 1 -MAXSIM = 10 -MINPOINTS = 1 -MAXPOINTS = 7 -OBJFUN = 1 -SNOBFITP = 0.5 -SNOBFITRESOLUTION = 0.100000000000E-004 -MAXTIME = 1000 -DATALIMITTERMS = T -NUMLIMITBASIS = T -CONVPEN = 0 -MONO = 3 -MULTI2 = 0 -MULTI3 = 0 -RATIOS = 0 -EXPFCNS = T -LINFCNS = T -LOGFCNS = T -SINFCNS = F -COSFCNS = F -CONSTANT = F -GRBFCNS = F -PRBF = F -LK = F -NCUSTOMBAS = 0 -OTHERBASIS = 0 -USEGPU = F -XSCALING = F -SCALEZ = F -MAXITER = 1 -TOLESTERROR = 0.999999977648E-002 -TOLSSE = 0 -FUNFORM = 1 -RBFPARAM = 1 -PRESET = -111111 -LINEARERROR = F -SOLVEMIP = F -DELTATERM = T -SHORTCUT = T -DIVE = T -FIRSTFEAS = F -MIPOPTCA = 0.500000007451E-001 -MIPOPTCR = 0.999999974738E-004 -CRTOL = 0.100000000000E-002 -CRNINITIAL = 0 -CRMAXITER = 10 -CRNVIOL = 5 -CRNTRIALS = 100 -CRNCUSTOM = 0 -NGROUPS = 0 -SIMULATOR = mysim -SIMIN = input.txt -SIMOUT = output.txt -SCRATCH = almscr -BARONEXE = almbaron.exe -=========================================================================== - -XLABELS XMIN XMAX XISINT -st 0.00000000000 1.65091098500 F -ZLABELS TOLMEANERROR TOLRELMETRIC TOLABSMETRIC MAXTERMS ZISINT TOLMAXERROR -Z1 0.00000000000 0.100000000000E-005 0.100000000000E-005 5 F 0.500000000000E-001 - -XDATA and ZDATA - 1.512777561 0.703608801 - 1.567937074 0.708311539 - 1.62164293 0.710396917 - -MONOPOWERS -0.5 1.5 2 -=========================================================================== -Total number of bases considered = 5 - -BASES considered - st - exp(st) - st**0.5 - st**1.5 - st**2 -=========================================================================== - - Step 0: Initializing data set - User provided an initial data set of 3 data points - We will sample no more data points at this stage - *************************************************************************** - Iteration 1 (Approx. elapsed time 0.0 s) - - Step 1: Model building using BIC - - Model building for variable Z1 - sigma in almsurr1 = 1.00000000000000 - ---- - BIC = 1.10 with Z1 = 0.56503112463080173988317 * st**0.5 - - Calculating quality metrics on observed data set. - Errors on observed data points - (for each data point: x, z, zmodel, square error, absolute error): - 1.512777561 0.703608801 0.694960160025 0.747989907093E-004 1.22918317145 - 1.567937074 0.708311539 0.707516685047 0 0.112218128562 - 1.62164293 0.710396917 0.71953179251 0.834459505821E-004 1.28588332682 - Maximum absolute errors (%) on observed data points - 1.28588332682 - - - Quality metrics for output Z1 - ----------------------------- - SSE OLR: 0.850E-30 - SSE: 0.159E-03 - RMSE: 0.728E-02 - R2: 1.00 - R2 adjusted: 1.00 - Model size: 1 - BIC: 1.10 - Cp: -1.00 - AICc: -23.5 - HQC: -29.3 - MSE: 0.159E-03 - SSEp: 0.159E-03 - RIC: 3.22 - MADp: 1.29 - - BETAS and BASES chosen for this output - 0.565031124630802 st**0.5 - - - Total execution time 0.0 s - Times breakdown - OLR time: 0.0 s in 16 ordinary linear regression problem(s) - MIP time: 0.0 s in 0 quadratic integer problem(s) - Simulation time: 0.0 s to simulate 0 point(s) - All other time: 0.0 s in 1 iteration(s) - - Normal termination - *************************************************************************** diff --git a/idaes_examples/archive/ripe/temptrace.trc b/idaes_examples/archive/ripe/temptrace.trc deleted file mode 100644 index 644e83b2..00000000 --- a/idaes_examples/archive/ripe/temptrace.trc +++ /dev/null @@ -1,76 +0,0 @@ -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 32, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.379E-03, 0.881E-01, 0.525E-01, 0.988, 1, 3.55, 3.31, -29.9, -187., -186., 0.294E-02, 0.881E-01, 69.6, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 32, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.51900110087274464731877 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 29, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.359E-03, 0.409E-01, 0.376E-01, 0.993, 1, 3.41, 3.26, -27.0, -188., -188., 0.151E-02, 0.409E-01, 77.6, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 29, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.54326638220273648638425 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 26, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.143E-03, 0.176E-01, 0.260E-01, 0.996, 1, 3.28, 3.24, -24.0, -188., -187., 0.733E-03, 0.176E-01, 84.4, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 26, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.56409136389973191239022 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 23, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.125E-03, 0.821E-02, 0.189E-01, 0.998, 1, 3.14, 3.23, -21.0, -180., -180., 0.391E-03, 0.821E-02, 89.9, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 23, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.58097796099196175045876 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 20, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.117E-03, 0.369E-02, 0.136E-01, 0.998, 1, 3.00, 3.22, -18.0, -170., -170., 0.205E-03, 0.369E-02, 94.9, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 20, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.59627190907604532554842 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 17, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.109E-03, 0.192E-02, 0.106E-01, 0.999, 1, 2.84, 3.22, -15.0, -152., -152., 0.128E-03, 0.192E-02, 99.0, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 17, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.60891015104919832268138 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 14, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.107E-03, 0.130E-02, 0.962E-02, 0.999, 1, 2.64, 3.22, -12.0, -128., -128., 0.108E-03, 0.130E-02, 102., 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 14, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.61924197147691284470739 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 11, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.958E-04, 0.122E-02, 0.105E-01, 0.997, 1, 2.40, 3.22, -9.00, -97.7, -98.4, 0.136E-03, 0.122E-02, 104., 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 11, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.62387747636893386982138 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 8, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.368E-04, 0.113E-02, 0.119E-01, 0.994, 1, 2.08, 3.22, -6.00, -68.2, -69.5, 0.188E-03, 0.113E-02, 102., 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 8, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.61718699265488141669778 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 5, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.618E-29, 0.625E-04, 0.354E-02, 0.999, 1, 1.61, 3.22, -3.00, -53.1, -55.5, 0.208E-04, 0.625E-04, 16.5, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 5, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 1.2673175353245353935705 * st**1.5 -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.143E-30, 0.173E-04, 0.240E-02, 1.00, 1, 1.10, 3.22, -1.00, -30.2, -36.0, 0.173E-04, 0.173E-04, 1.87, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.63334822685992542279365 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.918E-30, 0.486E-04, 0.403E-02, 1.00, 1, 1.10, 3.22, -1.00, -27.1, -32.9, 0.486E-04, 0.486E-04, 1.59, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.62906836705257784814194 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.185E-31, 0.183E-04, 0.247E-02, 1.00, 1, 1.10, 3.22, -1.00, -30.0, -35.8, 0.183E-04, 0.183E-04, 1.03, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.61409670114056258416468 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.496E-30, 0.222E-04, 0.272E-02, 1.00, 1, 1.10, 3.22, -1.00, -29.4, -35.3, 0.222E-04, 0.222E-04, 0.913, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.21105498219212401322942 * exp(st) -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.123E-30, 0.394E-04, 0.363E-02, 1.00, 1, 1.10, 3.22, -1.00, -27.7, -33.5, 0.394E-04, 0.394E-04, 0.986, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.21095275318545478326904 * exp(st) -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.111E-30, 0.871E-04, 0.539E-02, 1.00, 1, 1.10, 3.22, -1.00, -25.3, -31.2, 0.871E-04, 0.871E-04, 1.17, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.57536306576793760925170 * st**0.5 -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.740E-31, 0.101E-04, 0.184E-02, 1.00, 1, 1.10, 3.22, -1.00, -31.8, -37.6, 0.101E-04, 0.101E-04, 0.355, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.58903135703939046852184 * st**0.5 -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.281E-29, 0.218E-03, 0.852E-02, 1.00, 1, 1.10, 3.22, -1.00, -22.6, -28.4, 0.218E-03, 0.218E-03, 1.70, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.58356040616139981391797 * st**0.5 -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.850E-30, 0.159E-03, 0.728E-02, 1.00, 1, 1.10, 3.22, -1.00, -23.5, -29.3, 0.159E-03, 0.159E-03, 1.29, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.56503112463080173988317 * st**0.5 -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 32, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.379E-03, 0.881E-01, 0.525E-01, 0.988, 1, 3.55, 3.31, -29.9, -187., -186., 0.294E-02, 0.881E-01, 69.6, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 32, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.51900110087274464731877 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 29, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.359E-03, 0.409E-01, 0.376E-01, 0.993, 1, 3.41, 3.26, -27.0, -188., -188., 0.151E-02, 0.409E-01, 77.6, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 29, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.54326638220273648638425 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 26, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.143E-03, 0.176E-01, 0.260E-01, 0.996, 1, 3.28, 3.24, -24.0, -188., -187., 0.733E-03, 0.176E-01, 84.4, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 26, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.56409136389973191239022 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 23, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.125E-03, 0.821E-02, 0.189E-01, 0.998, 1, 3.14, 3.23, -21.0, -180., -180., 0.391E-03, 0.821E-02, 89.9, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 23, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.58097796099196175045876 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 20, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.117E-03, 0.369E-02, 0.136E-01, 0.998, 1, 3.00, 3.22, -18.0, -170., -170., 0.205E-03, 0.369E-02, 94.9, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 20, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.59627190907604532554842 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 17, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.109E-03, 0.192E-02, 0.106E-01, 0.999, 1, 2.84, 3.22, -15.0, -152., -152., 0.128E-03, 0.192E-02, 99.0, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 17, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.60891015104919832268138 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 14, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.107E-03, 0.130E-02, 0.962E-02, 0.999, 1, 2.64, 3.22, -12.0, -128., -128., 0.108E-03, 0.130E-02, 102., 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 14, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.61924197147691284470739 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 11, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.958E-04, 0.122E-02, 0.105E-01, 0.997, 1, 2.40, 3.22, -9.00, -97.7, -98.4, 0.136E-03, 0.122E-02, 104., 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 11, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.62387747636893386982138 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 8, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.368E-04, 0.113E-02, 0.119E-01, 0.994, 1, 2.08, 3.22, -6.00, -68.2, -69.5, 0.188E-03, 0.113E-02, 102., 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 8, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.61718699265488141669778 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 5, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.618E-29, 0.625E-04, 0.354E-02, 0.999, 1, 1.61, 3.22, -3.00, -53.1, -55.5, 0.208E-04, 0.625E-04, 16.5, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 5, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 1.2673175353245353935705 * st**1.5 -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.143E-30, 0.173E-04, 0.240E-02, 1.00, 1, 1.10, 3.22, -1.00, -30.2, -36.0, 0.173E-04, 0.173E-04, 1.87, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.63334822685992542279365 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.918E-30, 0.486E-04, 0.403E-02, 1.00, 1, 1.10, 3.22, -1.00, -27.1, -32.9, 0.486E-04, 0.486E-04, 1.59, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.62906836705257784814194 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.185E-31, 0.183E-04, 0.247E-02, 1.00, 1, 1.10, 3.22, -1.00, -30.0, -35.8, 0.183E-04, 0.183E-04, 1.03, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.61409670114056258416468 * st -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.496E-30, 0.222E-04, 0.272E-02, 1.00, 1, 1.10, 3.22, -1.00, -29.4, -35.3, 0.222E-04, 0.222E-04, 0.913, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.21105498219212401322942 * exp(st) -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.123E-30, 0.394E-04, 0.363E-02, 1.00, 1, 1.10, 3.22, -1.00, -27.7, -33.5, 0.394E-04, 0.394E-04, 0.986, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.21095275318545478326904 * exp(st) -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.111E-30, 0.871E-04, 0.539E-02, 1.00, 1, 1.10, 3.22, -1.00, -25.3, -31.2, 0.871E-04, 0.871E-04, 1.17, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.57536306576793760925170 * st**0.5 -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.740E-31, 0.101E-04, 0.184E-02, 1.00, 1, 1.10, 3.22, -1.00, -31.8, -37.6, 0.101E-04, 0.101E-04, 0.355, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.58903135703939046852184 * st**0.5 -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.281E-29, 0.218E-03, 0.852E-02, 1.00, 1, 1.10, 3.22, -1.00, -22.6, -28.4, 0.218E-03, 0.218E-03, 1.70, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.58356040616139981391797 * st**0.5 -#filename, NINPUTS, NOUTPUTS, INITIALPOINTS, OUTPUT, SET, INITIALIZER, SAMPLER, MODELER, BUILDER, GREEDYBUILD, BACKSTEPPER, GREEDYBACK, REGULARIZER, SOLVEMIP, SSEOLR, SSE, RMSE, R2, ModelSize, BIC, RIC, Cp, AICc, HQC, MSE, SSEp, MADp, OLRTime, numOLRs, OLRoneCalls, OLRoneFails, OLRgsiCalls, OLRgsiFails, OLRdgelCalls, OLRdgelFails, OLRclrCalls, OLRclrFails, OLRgmsCalls, OLRgmsFails, CLRTime, numCLRs, MIPTime, NumMIPs, LassoTime, Metric1Lasso, Metric2Lasso, LassoSuccess, LassoRed, nBasInitAct, nBas, SimTime, SimData, TotData, NdataConv, OtherTime, NumIters, IterConv, TimeConv, Step0Time, Step1Time, Step2Time, TotalTime, AlamoStatus, AlamoVersion, Model -temp.alm, 1, 1, 3, 1, 0, 3, 1, 1, 1, T, 0, T, 0, F, 0.850E-30, 0.159E-03, 0.728E-02, 1.00, 1, 1.10, 3.22, -1.00, -23.5, -29.3, 0.159E-03, 0.159E-03, 1.29, 0.0000000, 16, 5, 0, 0, 0, 11, 0, 0, 0, 0, 0, 0.0000000, 0, 0.0000000, 0, 0.0000000, 0.17976931+309, 0.17976931+309, F, 0.0000000, 5, 6, 0.0000000, 0, 3, 0, 0.0000000, 1, 0, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0.0000000, 0, 2022.10.7, Z1 = 0.56503112463080173988317 * st**0.5 diff --git a/idaes_examples/archive/ripe/tmpscratch b/idaes_examples/archive/ripe/tmpscratch deleted file mode 100644 index 517da6e1..00000000 --- a/idaes_examples/archive/ripe/tmpscratch +++ /dev/null @@ -1,57 +0,0 @@ - *************************************************************************** - ALAMO version 2022.10.7. Built: WIN-64 Fri Oct 7 21:02:38 EDT 2022 - - If you use this software, please cite: - Cozad, A., N. V. Sahinidis and D. C. Miller, - Automatic Learning of Algebraic Models for Optimization, - AIChE Journal, 60, 2211-2227, 2014. - - ALAMO is powered by the BARON software from http://www.minlp.com/ - *************************************************************************** - Licensee: Dan Gunter at US Department of Energy, dkgunter@lbl.gov. - *************************************************************************** - Reading input data - Checking input consistency and initializing data structures - Warning: powers of 1 will be discarded from the set of basis functions. - Warning: eliminating basis log(st) - - Step 0: Initializing data set - User provided an initial data set of 3 data points - We will sample no more data points at this stage - *************************************************************************** - Iteration 1 (Approx. elapsed time 0.0 s) - - Step 1: Model building using BIC - - Model building for variable Z1 - ---- - BIC = 1.10 with Z1 = 0.57 * st**0.5 - - Calculating quality metrics on observed data set. - - Quality metrics for output Z1 - ----------------------------- - SSE OLR: 0.850E-30 - SSE: 0.159E-03 - RMSE: 0.728E-02 - R2: 1.00 - R2 adjusted: 1.00 - Model size: 1 - BIC: 1.10 - Cp: -1.00 - AICc: -23.5 - HQC: -29.3 - MSE: 0.159E-03 - SSEp: 0.159E-03 - RIC: 3.22 - MADp: 1.29 - - Total execution time 0.0 s - Times breakdown - OLR time: 0.0 s in 16 ordinary linear regression problem(s) - MIP time: 0.0 s in 0 quadratic integer problem(s) - Simulation time: 0.0 s to simulate 0 point(s) - All other time: 0.0 s in 1 iteration(s) - - Normal termination - ***************************************************************************