diff --git a/CFMvsRPM.csv b/CFMvsRPM.csv new file mode 100644 index 0000000..e6f4815 --- /dev/null +++ b/CFMvsRPM.csv @@ -0,0 +1,2 @@ +0.0, 0.0 +2500.0, 100.0 diff --git a/Chip_temperature_control.prj b/Chip_temperature_control.prj new file mode 100644 index 0000000..92c6696 --- /dev/null +++ b/Chip_temperature_control.prj @@ -0,0 +1,2 @@ + + diff --git a/Demo_description.pdf b/Demo_description.pdf new file mode 100755 index 0000000..7c268d6 Binary files /dev/null and b/Demo_description.pdf differ diff --git a/HeatInput.mat b/HeatInput.mat new file mode 100644 index 0000000..18c2e70 Binary files /dev/null and b/HeatInput.mat differ diff --git a/README.md b/README.md new file mode 100755 index 0000000..1e8f0c1 --- /dev/null +++ b/README.md @@ -0,0 +1,57 @@ +# Modeling Systems Governed by PDEs in Simulink + +The system being modeled in this Simulink example is a variable-speed fan cooling a CPU which, +depending on the model and the operating point, can generate variable amount of heat. Each component +of the system is modeled using techniques that easily incorporate empirical data and technical +specifications, and all assumptions are stated in the following discussion regarding levels of +modeling fidelity. + +The plant in this system is the thermal dynamics of the heat-generating CPU and the heat-dissipating heat +sink. These dynamics are modeled by a finite element formulation of the heat equation on the 3D +geometry. The geometry, meshing, and discretization in this example are done using MATLAB’s PDE +Toolbox. The finite element matrices generated can then be solved using Simulink’s Descriptor State Space +block. For more information on time-dependent finite-element formulations, please see the MathWorks +documentation. +The dominant mode of heat transfer in this scenario is due to convection. A convective boundary condition +is constructed in Simulink for the ducted airflow where forced convection coefficients +would be applied on the internal fin surfaces, and free convection coefficients are applied on the +external facing surfaces of the system. +The heat generation of the CPU can be controlled by the user in this formulation as an input Wattage. This +demonstration provides examples of different loadings of the processor that lead to different heat +generation, thus lending itself useful for design decisions in determining if a certain heat sink is suitable +for a specific CPU. + +# Running the Model + +This example is organized inside a Simulink Project. Once the project is opened, running “top_script” will +load all the variables needed for the simulation and then execute a parameter sweep. Six scenarios are +included in this example. The six simulations run varied levels of heat generation from the CPU as input +to the plant subsystem. +Upon completion of the parameter sweep, the Simulation Manager will launch. The socket temperature +signal is logged using Simulink Data Inspector and can be visualized by selecting the simulations of +interest and clicking the “Show Results” option. The Signal Editor block, data logging, and adding +additional systems to the model can all provide opportunities to expand on physical system modeling +and the engineering design decision process that goes along with it. +Note, there is an included “debug” plant model that uses the same parameters, but a simpler geometry +with fewer mesh nodes to reduce the number of degrees of freedom. This is useful for debugging the +model and iterating on other parameters in the system outside of the plant. This feature can be utilized +by commenting out “heat_sink_defs” in the “top_script” and replacing it with “heat_sink_defs_DEBUG”. + + +Contents: + +Chip_temperature_control.prj: the Simulink project file + +CFMvsRPM.csv, RPMvsV.csv: data tables used to construct 1D lookup tables in Simulink model, can be digitized data from plots + +fan.slx, heat_sink.slx, sensor.slx: subsystem files referenced by the top level model + +fan_defs.m, heat_sink_defs.m, heat_sink_defs_DEBUG.m, sensor_defs.m: MATLAB scripts to initialize subsystem parameters + +top_system.slx: top level model of complete control systems + +HeatInput.mat: MAT file that defines Signal Editor scenarios + +top_script.m: MATLAB script that calls subsytem scripts, runs simulations with different input scenarios, and opens Simulation Manager + +Demo_description.pdf: Detailed write-up of model development and design decisions made \ No newline at end of file diff --git a/RPMvsV.csv b/RPMvsV.csv new file mode 100644 index 0000000..856c2ac --- /dev/null +++ b/RPMvsV.csv @@ -0,0 +1,2 @@ +0.0, 0.0 +12.0, 2500.0 diff --git a/SECURITY.md b/SECURITY.md new file mode 100644 index 0000000..2fa158c --- /dev/null +++ b/SECURITY.md @@ -0,0 +1,6 @@ +# Reporting Security Vulnerabilities + +If you believe you have discovered a security vulnerability, please report it to +[security@mathworks.com](mailto:security@mathworks.com). Please see +[MathWorks Vulnerability Disclosure Policy for Security Researchers](https://www.mathworks.com/company/aboutus/policies_statements/vulnerability-disclosure-policy.html) +for additional information. diff --git a/fan.slx b/fan.slx new file mode 100644 index 0000000..262ccce Binary files /dev/null and b/fan.slx differ diff --git a/fan_defs.m b/fan_defs.m new file mode 100644 index 0000000..6108648 --- /dev/null +++ b/fan_defs.m @@ -0,0 +1,7 @@ +%% cooling fan +tauFan = 0.2192; +%% load digitized data +V2RPM = readmatrix('RPMvsV.csv'); +RPM2CFM = readmatrix('CFMvsRPM.csv'); +%% conversion constants +CFM2CMS = 0.00047194745; % CFM to cubic meters per second \ No newline at end of file diff --git a/figures/fan.jpg b/figures/fan.jpg new file mode 100755 index 0000000..d084a84 Binary files /dev/null and b/figures/fan.jpg differ diff --git a/figures/heat_sink.jpg b/figures/heat_sink.jpg new file mode 100755 index 0000000..a5e12bd Binary files /dev/null and b/figures/heat_sink.jpg differ diff --git a/figures/sensor.jpg b/figures/sensor.jpg new file mode 100755 index 0000000..01bdaa6 Binary files /dev/null and b/figures/sensor.jpg differ diff --git a/heat_sink.slx b/heat_sink.slx new file mode 100644 index 0000000..0ec208d Binary files /dev/null and b/heat_sink.slx differ diff --git a/heat_sink_defs.m b/heat_sink_defs.m new file mode 100644 index 0000000..889b59a --- /dev/null +++ b/heat_sink_defs.m @@ -0,0 +1,86 @@ +%% heat sink +heatsink = createpde('thermal','transient'); +%% heat sink+chip geometry +W = 27*10^-3; % heat sink width +H = 17.5*10^-3; % heat sink fin height +t = 2*10^-3; % approximated fin thickness +nFin = 8; % number of fins on heat sink +dFin = (W - (nFin*t))/(nFin-1); % space between fins, calculated from approximations +R1 = [3 4 0.0 W W 0.0 0.0 0.0 t t]'; % base plate +R2 = [3 4 (0*(t+dFin)) (0*(t+dFin))+t (0*(t+dFin))+t (0*(t+dFin)) t t H-t H-t]'; % fin1 +R3 = [3 4 (1*(t+dFin)) (1*(t+dFin))+t (1*(t+dFin))+t (1*(t+dFin)) t t H-t H-t]'; % fin2 +R4 = [3 4 (2*(t+dFin)) (2*(t+dFin))+t (2*(t+dFin))+t (2*(t+dFin)) t t H-t H-t]'; % fin3 +R5 = [3 4 (3*(t+dFin)) (3*(t+dFin))+t (3*(t+dFin))+t (3*(t+dFin)) t t H-t H-t]'; % fin4 +R6 = [3 4 (4*(t+dFin)) (4*(t+dFin))+t (4*(t+dFin))+t (4*(t+dFin)) t t H-t H-t]'; % fin5 +R7 = [3 4 (5*(t+dFin)) (5*(t+dFin))+t (5*(t+dFin))+t (5*(t+dFin)) t t H-t H-t]'; % fin6 +R8 = [3 4 (6*(t+dFin)) (6*(t+dFin))+t (6*(t+dFin))+t (6*(t+dFin)) t t H-t H-t]'; % fin7 +R9 = [3 4 (7*(t+dFin)) (7*(t+dFin))+t (7*(t+dFin))+t (7*(t+dFin)) t t H-t H-t]'; % fin8 +R0 = [3 4 0.001 0.026 0.026 0.001 0.0 0.0 -t -t]'; % chip +gd = [R1 R2 R3 R4 R5 R6 R7 R8 R9 R0]; % Geometry description matrix +sf = 'R1+R2+R3+R4+R5+R6+R7+R8+R9+R0'; % Set formula for adding 2D shapes +ns = (char('R1','R2','R3','R4','R5','R6','R7','R8','R9','R0'))'; % Name-space matrix +g = decsg(gd,sf,ns); % Decompose constructive solid 2-D geometry into minimal regions +pg = geometryFromEdges(heatsink,g); % apply geometry to model +gm = extrude(pg,W); % generate 3D geometry from 2D cross section +heatsink.Geometry = gm; % replace model geometry with 3D +m = generateMesh(heatsink,'Hmin',t,'Hgrad',1.9); % try to min(nDoF) +%% visualize geometry to get i/o #s +% figure; pdegplot(heatsink,'FaceLabels','on') % visualize geometry +% figure; pdegplot(heatsink,'CellLabels','on') +% figure; pdemesh(m); axis equal +% figure; pdemesh(m,'NodeLabels','on') % visualize mesh +CPUcell = 1; +freeBCfaces = 1:20; % faces that do not see flow, using free convection +forcedBCfaces = 21:heatsink.Geometry.NumFaces; % faces aligned with flow +outID = findNodes(m,'nearest',[0.026 -t/2 W/2]'); % middle of yz side of casing +%% internal properties +k = 210; % W*m^-1*K^-1 +rho = 2710; % kg/m^3 +Cp = 900; % J*kg^-1*K^-1 +mtl = thermalProperties(heatsink,'ThermalConductivity',k, ... + 'MassDensity',rho, ... + 'SpecificHeat',Cp); % aluminum alloy 6060 T6 +chipHeat = 1; % Watts +chipW = 25e-3; % m +chipL = W; % m +chipH = t; % m +heatPerVol = chipHeat/(chipL*chipW*chipH); % W/m^3 +heatSource = internalHeatSource(heatsink,heatPerVol,'Cell',CPUcell); +IC = 294; % Kelvin +thermIC = thermalIC(heatsink,IC); % T = IC everywhere @T=0 +%% boundary conditions +Tinf = IC; % ambient temperature, Kelvin +xSectionA = (2*W)*(2*H); % duct cross-sectional area, m^2 +rho = 1.225; % kg/m^3 +h_free = 9.0; +h_forced = [ ... +0.0, h_free; ... +3.0, 50.0; ... +]; % [V_linear, convective heat transfer coeff] +h_forced(:,1) = h_forced(:,1) * xSectionA * rho; % convert to h = f(mdot) +freeBC = thermalBC(heatsink,'Face',freeBCfaces,'HeatFlux',1); % used as convective BC +forcedBC = thermalBC(heatsink,'Face',forcedBCfaces,'HeatFlux',1); % used as convective BC +%% FE formulation +femat = assembleFEMatrices(heatsink); +K = femat.K; % is the stiffness matrix, the integral of the c coefficient against the basis functions +M = femat.M; % is the mass matrix, the integral of the m or d coefficient against the basis functions. +A = femat.A; % is the integral of the a coefficient against the basis functions. +F = femat.F; % is the integral of the f coefficient against the basis functions. +Q = femat.Q; % is the integral of the q boundary condition against the basis functions. +G = femat.G; % is the integral of the g boundary condition against the basis functions. +H = femat.H; % The H and R matrices come directly from the Dirichlet conditions and the mesh. +R = femat.R; % % +%% construct SL vectors +nDoF = size(K,1); +freeBCnodes = findNodes(m,'Region','Face',freeBCfaces); +unitFreeBC = zeros(nDoF,1); +unitFreeBC(freeBCnodes) = 1; +normalizedFreeBC = zeros(nDoF,1); +normalizedFreeBC(freeBCnodes) = G(freeBCnodes); +forcedBCnodes = findNodes(m,'Region','Face',forcedBCfaces); +unitForcedBC = zeros(nDoF,1); +unitForcedBC(forcedBCnodes) = 1; +normalizedForcedBC = zeros(nDoF,1); +normalizedForcedBC(forcedBCnodes) = G(forcedBCnodes); +x0 = ones(nDoF,1)*IC; +unitCPUHeat = full(F); \ No newline at end of file diff --git a/heat_sink_defs_DEBUG.m b/heat_sink_defs_DEBUG.m new file mode 100644 index 0000000..cf7644b --- /dev/null +++ b/heat_sink_defs_DEBUG.m @@ -0,0 +1,75 @@ +%% heat sink +heatsink = createpde('thermal','transient'); +%% heat sink+chip geometry +L = 15e-3; % m +R1 = [3 4 0.0 L L 0.0 0.0 0.0 L L]'; % top cube +R2 = [3 4 0.0 L L 0.0 0.0 0.0 -L -L]'; % bot cube +gd = [R1 R2]; +sf = 'R1+R2'; +ns = (char('R1','R2'))'; + +g = decsg(gd,sf,ns); % Decompose constructive solid 2-D geometry into minimal regions +pg = geometryFromEdges(heatsink,g); % apply geometry to model +gm = extrude(pg,L); % generate 3D geometry from 2D cross section +heatsink.Geometry = gm; % replace model geometry with 3D +m = generateMesh(heatsink,'Hmin',5e-3); % try to min(nDoF) +%% visualize geometry to get i/o #s +% figure; pdegplot(heatsink,'FaceLabels','on') % visualize geometry +% figure; pdegplot(heatsink,'CellLabels','on') +% figure; pdemesh(m); axis equal +% figure; pdemesh(m,'NodeLabels','on') % visualize mesh +CPUcell = 1; +freeBCfaces = [1 3 6 8 10]; % faces that do not see flow, using free convection +forcedBCfaces = [2 4 5 9 11]; % faces aligned with flow +outID = 7; % top right corner +%% internal properties +k = 210; % W*m^-1*K^-1 +rho = 2710; % kg/m^3 +Cp = 900; % J*kg^-1*K^-1 +mtl = thermalProperties(heatsink,'ThermalConductivity',k, ... + 'MassDensity',rho, ... + 'SpecificHeat',Cp); % aluminum alloy 6060 T6 +chipHeat = 1; % Watts +chipW = L; % m +chipL = L; % m +chipH = L; % m +heatPerVol = chipHeat/(chipL*chipW*chipH); % W/m^3 +heatSource = internalHeatSource(heatsink,heatPerVol,'Cell',CPUcell); +IC = 294; % Kelvin +thermIC = thermalIC(heatsink,IC); % T = IC everywhere @T=0 +%% boundary conditions +Tinf = IC; % ambient temperature, Kelvin +xSectionA = (2*L)^2; % duct cross-sectional area, m^2 +rho = 1.225; % kg/m^3 +h_free = 9.0; +h_forced = [ ... +0.0, h_free; ... +3.0, 50.0; ... +]; % [V_induced, convective heat transfer coeff] +h_forced(:,1) = h_forced(:,1) * xSectionA * rho; % convert to h = f(mdot) +freeBC = thermalBC(heatsink,'Face',freeBCfaces,'HeatFlux',1); % used as convective BC +forcedBC = thermalBC(heatsink,'Face',forcedBCfaces,'HeatFlux',1); % used as convective BC +%% FE formulation +femat = assembleFEMatrices(heatsink); +K = femat.K; % is the stiffness matrix, the integral of the c coefficient against the basis functions +M = femat.M; % is the mass matrix, the integral of the m or d coefficient against the basis functions. +A = femat.A; % is the integral of the a coefficient against the basis functions. +F = femat.F; % is the integral of the f coefficient against the basis functions. +Q = femat.Q; % is the integral of the q boundary condition against the basis functions. +G = femat.G; % is the integral of the g boundary condition against the basis functions. +H = femat.H; % The H and R matrices come directly from the Dirichlet conditions and the mesh. +R = femat.R; % % +%% construct SL vectors +nDoF = size(K,1); +freeBCnodes = findNodes(m,'Region','Face',freeBCfaces); +unitFreeBC = zeros(nDoF,1); +unitFreeBC(freeBCnodes) = 1; +normalizedFreeBC = zeros(nDoF,1); +normalizedFreeBC(freeBCnodes) = G(freeBCnodes); +forcedBCnodes = findNodes(m,'Region','Face',forcedBCfaces); +unitForcedBC = zeros(nDoF,1); +unitForcedBC(forcedBCnodes) = 1; +normalizedForcedBC = zeros(nDoF,1); +normalizedForcedBC(forcedBCnodes) = G(forcedBCnodes); +x0 = ones(nDoF,1)*IC; +unitCPUHeat = full(F); \ No newline at end of file diff --git a/license.txt b/license.txt new file mode 100644 index 0000000..082b50d --- /dev/null +++ b/license.txt @@ -0,0 +1,7 @@ +Copyright (c) 2020, The MathWorks, Inc. +All rights reserved. +Redistribution and use in source and binary forms, with or without modification, are permitted provided that the following conditions are met: +1. Redistributions of source code must retain the above copyright notice, this list of conditions and the following disclaimer. +2. Redistributions in binary form must reproduce the above copyright notice, this list of conditions and the following disclaimer in the documentation and/or other materials provided with the distribution. +3. In all cases, the software is, and all modifications and derivatives of the software shall be, licensed to you solely for use in conjunction with MathWorks products and service offerings. +THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS "AS IS" AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE COPYRIGHT HOLDER OR CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE. diff --git a/resources/project/KAXfQgCar2Yb8zOxgvf9hdmLP1E/Eif_Q8-eW8o4x10LdM3S54txieId.xml b/resources/project/KAXfQgCar2Yb8zOxgvf9hdmLP1E/Eif_Q8-eW8o4x10LdM3S54txieId.xml new file mode 100644 index 0000000..29cd5a0 --- /dev/null +++ b/resources/project/KAXfQgCar2Yb8zOxgvf9hdmLP1E/Eif_Q8-eW8o4x10LdM3S54txieId.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/KAXfQgCar2Yb8zOxgvf9hdmLP1E/Eif_Q8-eW8o4x10LdM3S54txieIp.xml b/resources/project/KAXfQgCar2Yb8zOxgvf9hdmLP1E/Eif_Q8-eW8o4x10LdM3S54txieIp.xml new file mode 100644 index 0000000..6414478 --- /dev/null +++ b/resources/project/KAXfQgCar2Yb8zOxgvf9hdmLP1E/Eif_Q8-eW8o4x10LdM3S54txieIp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/2kj09UetkV_lru3gvSPXnY6-nM4d.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/2kj09UetkV_lru3gvSPXnY6-nM4d.xml new file mode 100644 index 0000000..5a6f802 --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/2kj09UetkV_lru3gvSPXnY6-nM4d.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/2kj09UetkV_lru3gvSPXnY6-nM4p.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/2kj09UetkV_lru3gvSPXnY6-nM4p.xml new file mode 100644 index 0000000..7d7cdf5 --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/2kj09UetkV_lru3gvSPXnY6-nM4p.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/KKyDJtbdIBOlaeHmIZd5VX6vqx8d.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/KKyDJtbdIBOlaeHmIZd5VX6vqx8d.xml new file mode 100644 index 0000000..14d104f --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/KKyDJtbdIBOlaeHmIZd5VX6vqx8d.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/KKyDJtbdIBOlaeHmIZd5VX6vqx8p.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/KKyDJtbdIBOlaeHmIZd5VX6vqx8p.xml new file mode 100644 index 0000000..e9b99bc --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/KKyDJtbdIBOlaeHmIZd5VX6vqx8p.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/QWNDYJD5mGW1bWYvPx9DtKnxzw4d.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/QWNDYJD5mGW1bWYvPx9DtKnxzw4d.xml new file mode 100644 index 0000000..5272801 --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/QWNDYJD5mGW1bWYvPx9DtKnxzw4d.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/QWNDYJD5mGW1bWYvPx9DtKnxzw4p.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/QWNDYJD5mGW1bWYvPx9DtKnxzw4p.xml new file mode 100644 index 0000000..4985b81 --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/QWNDYJD5mGW1bWYvPx9DtKnxzw4p.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/R1RggVhA72agIvELiuhWPRS8F0Id.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/R1RggVhA72agIvELiuhWPRS8F0Id.xml new file mode 100644 index 0000000..27ca3e7 --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/R1RggVhA72agIvELiuhWPRS8F0Id.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/R1RggVhA72agIvELiuhWPRS8F0Ip.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/R1RggVhA72agIvELiuhWPRS8F0Ip.xml new file mode 100644 index 0000000..b54f8b0 --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/R1RggVhA72agIvELiuhWPRS8F0Ip.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/aEHSZBIY-yve10yGis12Zr5DLZod.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/aEHSZBIY-yve10yGis12Zr5DLZod.xml new file mode 100644 index 0000000..5a873c8 --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/aEHSZBIY-yve10yGis12Zr5DLZod.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/aEHSZBIY-yve10yGis12Zr5DLZop.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/aEHSZBIY-yve10yGis12Zr5DLZop.xml new file mode 100644 index 0000000..1630157 --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/aEHSZBIY-yve10yGis12Zr5DLZop.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/j4xwF_j8iFTVayUMfxLgMnTbencd.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/j4xwF_j8iFTVayUMfxLgMnTbencd.xml new file mode 100644 index 0000000..59cb0be --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/j4xwF_j8iFTVayUMfxLgMnTbencd.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/j4xwF_j8iFTVayUMfxLgMnTbencp.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/j4xwF_j8iFTVayUMfxLgMnTbencp.xml new file mode 100644 index 0000000..13c5f03 --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/j4xwF_j8iFTVayUMfxLgMnTbencp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/r8LR4nLmg9ai3oHrW1r_-KocQzkd.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/r8LR4nLmg9ai3oHrW1r_-KocQzkd.xml new file mode 100644 index 0000000..b56f659 --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/r8LR4nLmg9ai3oHrW1r_-KocQzkd.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/r8LR4nLmg9ai3oHrW1r_-KocQzkp.xml b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/r8LR4nLmg9ai3oHrW1r_-KocQzkp.xml new file mode 100644 index 0000000..747ffce --- /dev/null +++ b/resources/project/NjSPEMsIuLUyIpr2u1Js5bVPsOs/r8LR4nLmg9ai3oHrW1r_-KocQzkp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/Project.xml b/resources/project/Project.xml new file mode 100644 index 0000000..131caf3 --- /dev/null +++ b/resources/project/Project.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/fjRQtWiSIy7hIlj-Kmk87M7s21k/NjSPEMsIuLUyIpr2u1Js5bVPsOsd.xml b/resources/project/fjRQtWiSIy7hIlj-Kmk87M7s21k/NjSPEMsIuLUyIpr2u1Js5bVPsOsd.xml new file mode 100644 index 0000000..ef38945 --- /dev/null +++ b/resources/project/fjRQtWiSIy7hIlj-Kmk87M7s21k/NjSPEMsIuLUyIpr2u1Js5bVPsOsd.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/fjRQtWiSIy7hIlj-Kmk87M7s21k/NjSPEMsIuLUyIpr2u1Js5bVPsOsp.xml b/resources/project/fjRQtWiSIy7hIlj-Kmk87M7s21k/NjSPEMsIuLUyIpr2u1Js5bVPsOsp.xml new file mode 100644 index 0000000..c9f987f --- /dev/null +++ b/resources/project/fjRQtWiSIy7hIlj-Kmk87M7s21k/NjSPEMsIuLUyIpr2u1Js5bVPsOsp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/0Xjd6EFmVVFAUJrpsHqsPFwdsO4d.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/0Xjd6EFmVVFAUJrpsHqsPFwdsO4d.xml new file mode 100644 index 0000000..80b5b16 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/0Xjd6EFmVVFAUJrpsHqsPFwdsO4d.xml @@ -0,0 +1,6 @@ + + + + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/0Xjd6EFmVVFAUJrpsHqsPFwdsO4p.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/0Xjd6EFmVVFAUJrpsHqsPFwdsO4p.xml new file mode 100644 index 0000000..14552ae --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/0Xjd6EFmVVFAUJrpsHqsPFwdsO4p.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/0dYxxLzMsdNGH3XdTTmi9lGoZQMd.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/0dYxxLzMsdNGH3XdTTmi9lGoZQMd.xml new file mode 100644 index 0000000..80b5b16 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/0dYxxLzMsdNGH3XdTTmi9lGoZQMd.xml @@ -0,0 +1,6 @@ + + + + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/0dYxxLzMsdNGH3XdTTmi9lGoZQMp.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/0dYxxLzMsdNGH3XdTTmi9lGoZQMp.xml new file mode 100644 index 0000000..13eaa7c --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/0dYxxLzMsdNGH3XdTTmi9lGoZQMp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/1DnoiFxZN42m4k1BBfwyHivx1nEd.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/1DnoiFxZN42m4k1BBfwyHivx1nEd.xml new file mode 100644 index 0000000..80b5b16 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/1DnoiFxZN42m4k1BBfwyHivx1nEd.xml @@ -0,0 +1,6 @@ + + + + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/1DnoiFxZN42m4k1BBfwyHivx1nEp.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/1DnoiFxZN42m4k1BBfwyHivx1nEp.xml new file mode 100644 index 0000000..2dad815 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/1DnoiFxZN42m4k1BBfwyHivx1nEp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/1E_ORUYoUaqXIBh7b3Z8QCO6F5Ed.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/1E_ORUYoUaqXIBh7b3Z8QCO6F5Ed.xml new file mode 100644 index 0000000..1c0844e --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/1E_ORUYoUaqXIBh7b3Z8QCO6F5Ed.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/1E_ORUYoUaqXIBh7b3Z8QCO6F5Ep.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/1E_ORUYoUaqXIBh7b3Z8QCO6F5Ep.xml new file mode 100644 index 0000000..bb0c579 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/1E_ORUYoUaqXIBh7b3Z8QCO6F5Ep.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/2uRqUwgzsMPtKV1vY4JvGEQwdJId.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/2uRqUwgzsMPtKV1vY4JvGEQwdJId.xml new file mode 100644 index 0000000..1c0844e --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/2uRqUwgzsMPtKV1vY4JvGEQwdJId.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/2uRqUwgzsMPtKV1vY4JvGEQwdJIp.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/2uRqUwgzsMPtKV1vY4JvGEQwdJIp.xml new file mode 100644 index 0000000..37f0cdf --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/2uRqUwgzsMPtKV1vY4JvGEQwdJIp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/3hA_e7BSFNrQ_AeMEKcFcjbKf48d.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/3hA_e7BSFNrQ_AeMEKcFcjbKf48d.xml new file mode 100644 index 0000000..80b5b16 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/3hA_e7BSFNrQ_AeMEKcFcjbKf48d.xml @@ -0,0 +1,6 @@ + + + + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/3hA_e7BSFNrQ_AeMEKcFcjbKf48p.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/3hA_e7BSFNrQ_AeMEKcFcjbKf48p.xml new file mode 100644 index 0000000..6969bab --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/3hA_e7BSFNrQ_AeMEKcFcjbKf48p.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/43hI6-JDdq4BK8Y3zCHhHncPvxEd.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/43hI6-JDdq4BK8Y3zCHhHncPvxEd.xml new file mode 100644 index 0000000..80b5b16 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/43hI6-JDdq4BK8Y3zCHhHncPvxEd.xml @@ -0,0 +1,6 @@ + + + + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/43hI6-JDdq4BK8Y3zCHhHncPvxEp.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/43hI6-JDdq4BK8Y3zCHhHncPvxEp.xml new file mode 100644 index 0000000..656bac4 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/43hI6-JDdq4BK8Y3zCHhHncPvxEp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/53YexDGPy3FYf4wMWCGdrK0JQ80d.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/53YexDGPy3FYf4wMWCGdrK0JQ80d.xml new file mode 100644 index 0000000..d9a9e30 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/53YexDGPy3FYf4wMWCGdrK0JQ80d.xml @@ -0,0 +1,6 @@ + + + + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/53YexDGPy3FYf4wMWCGdrK0JQ80p.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/53YexDGPy3FYf4wMWCGdrK0JQ80p.xml new file mode 100644 index 0000000..eec7bc4 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/53YexDGPy3FYf4wMWCGdrK0JQ80p.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/P-TwujwKxiHFckor3i_v4St-Vd4d.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/P-TwujwKxiHFckor3i_v4St-Vd4d.xml new file mode 100644 index 0000000..80b5b16 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/P-TwujwKxiHFckor3i_v4St-Vd4d.xml @@ -0,0 +1,6 @@ + + + + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/P-TwujwKxiHFckor3i_v4St-Vd4p.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/P-TwujwKxiHFckor3i_v4St-Vd4p.xml new file mode 100644 index 0000000..8f99c2c --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/P-TwujwKxiHFckor3i_v4St-Vd4p.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/QMJD9OLFzxcTTbPOoh-ahQ4zTRUd.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/QMJD9OLFzxcTTbPOoh-ahQ4zTRUd.xml new file mode 100644 index 0000000..1c0844e --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/QMJD9OLFzxcTTbPOoh-ahQ4zTRUd.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/QMJD9OLFzxcTTbPOoh-ahQ4zTRUp.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/QMJD9OLFzxcTTbPOoh-ahQ4zTRUp.xml new file mode 100644 index 0000000..d86fd89 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/QMJD9OLFzxcTTbPOoh-ahQ4zTRUp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/QWSCDDep1Nd5ckFTw18-JAYehmgd.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/QWSCDDep1Nd5ckFTw18-JAYehmgd.xml new file mode 100644 index 0000000..1c0844e --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/QWSCDDep1Nd5ckFTw18-JAYehmgd.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/QWSCDDep1Nd5ckFTw18-JAYehmgp.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/QWSCDDep1Nd5ckFTw18-JAYehmgp.xml new file mode 100644 index 0000000..4fe8e03 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/QWSCDDep1Nd5ckFTw18-JAYehmgp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/TMK4UzWHdRLhy_w-CHt9y11Q8XAd.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/TMK4UzWHdRLhy_w-CHt9y11Q8XAd.xml new file mode 100644 index 0000000..1c0844e --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/TMK4UzWHdRLhy_w-CHt9y11Q8XAd.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/TMK4UzWHdRLhy_w-CHt9y11Q8XAp.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/TMK4UzWHdRLhy_w-CHt9y11Q8XAp.xml new file mode 100644 index 0000000..75ca315 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/TMK4UzWHdRLhy_w-CHt9y11Q8XAp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/W5XWJSpJBP0vh6MfHX_YU5GK6Fod.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/W5XWJSpJBP0vh6MfHX_YU5GK6Fod.xml new file mode 100644 index 0000000..80b5b16 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/W5XWJSpJBP0vh6MfHX_YU5GK6Fod.xml @@ -0,0 +1,6 @@ + + + + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/W5XWJSpJBP0vh6MfHX_YU5GK6Fop.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/W5XWJSpJBP0vh6MfHX_YU5GK6Fop.xml new file mode 100644 index 0000000..ef884c7 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/W5XWJSpJBP0vh6MfHX_YU5GK6Fop.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/YXf0ge-iFFkbszlkcBZDVomrlf4d.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/YXf0ge-iFFkbszlkcBZDVomrlf4d.xml new file mode 100644 index 0000000..80b5b16 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/YXf0ge-iFFkbszlkcBZDVomrlf4d.xml @@ -0,0 +1,6 @@ + + + + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/YXf0ge-iFFkbszlkcBZDVomrlf4p.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/YXf0ge-iFFkbszlkcBZDVomrlf4p.xml new file mode 100644 index 0000000..7f97de1 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/YXf0ge-iFFkbszlkcBZDVomrlf4p.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/nZjUr6OThzhHsozt-hP6MPJCWzQd.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/nZjUr6OThzhHsozt-hP6MPJCWzQd.xml new file mode 100644 index 0000000..80b5b16 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/nZjUr6OThzhHsozt-hP6MPJCWzQd.xml @@ -0,0 +1,6 @@ + + + + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/nZjUr6OThzhHsozt-hP6MPJCWzQp.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/nZjUr6OThzhHsozt-hP6MPJCWzQp.xml new file mode 100644 index 0000000..06fd541 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/nZjUr6OThzhHsozt-hP6MPJCWzQp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/oZzF-3sGtMboTTAg51nURTMvJkYd.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/oZzF-3sGtMboTTAg51nURTMvJkYd.xml new file mode 100644 index 0000000..80b5b16 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/oZzF-3sGtMboTTAg51nURTMvJkYd.xml @@ -0,0 +1,6 @@ + + + + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/oZzF-3sGtMboTTAg51nURTMvJkYp.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/oZzF-3sGtMboTTAg51nURTMvJkYp.xml new file mode 100644 index 0000000..ee7194a --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/oZzF-3sGtMboTTAg51nURTMvJkYp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/qD-kr16wmwlzR-nIg1IG_vvRrWkd.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/qD-kr16wmwlzR-nIg1IG_vvRrWkd.xml new file mode 100644 index 0000000..1c0844e --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/qD-kr16wmwlzR-nIg1IG_vvRrWkd.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/qD-kr16wmwlzR-nIg1IG_vvRrWkp.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/qD-kr16wmwlzR-nIg1IG_vvRrWkp.xml new file mode 100644 index 0000000..4b0f6fe --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/qD-kr16wmwlzR-nIg1IG_vvRrWkp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/rh0jHbNfmojECiiHH7BQHmZTsWkd.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/rh0jHbNfmojECiiHH7BQHmZTsWkd.xml new file mode 100644 index 0000000..1c0844e --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/rh0jHbNfmojECiiHH7BQHmZTsWkd.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/rh0jHbNfmojECiiHH7BQHmZTsWkp.xml b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/rh0jHbNfmojECiiHH7BQHmZTsWkp.xml new file mode 100644 index 0000000..d701a85 --- /dev/null +++ b/resources/project/qaw0eS1zuuY1ar9TdPn1GMfrjbQ/rh0jHbNfmojECiiHH7BQHmZTsWkp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/root/6x1BhZX_fLnKpcwqra0qFwv1jIgp.xml b/resources/project/root/6x1BhZX_fLnKpcwqra0qFwv1jIgp.xml new file mode 100644 index 0000000..fecfedc --- /dev/null +++ b/resources/project/root/6x1BhZX_fLnKpcwqra0qFwv1jIgp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/root/GiiBklLgTxteCEmomM8RCvWT0nQd.xml b/resources/project/root/GiiBklLgTxteCEmomM8RCvWT0nQd.xml new file mode 100644 index 0000000..63f97bb --- /dev/null +++ b/resources/project/root/GiiBklLgTxteCEmomM8RCvWT0nQd.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/root/GiiBklLgTxteCEmomM8RCvWT0nQp.xml b/resources/project/root/GiiBklLgTxteCEmomM8RCvWT0nQp.xml new file mode 100644 index 0000000..61c6504 --- /dev/null +++ b/resources/project/root/GiiBklLgTxteCEmomM8RCvWT0nQp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/root/KAXfQgCar2Yb8zOxgvf9hdmLP1Ep.xml b/resources/project/root/KAXfQgCar2Yb8zOxgvf9hdmLP1Ep.xml new file mode 100644 index 0000000..f2649aa --- /dev/null +++ b/resources/project/root/KAXfQgCar2Yb8zOxgvf9hdmLP1Ep.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/root/NmGqIpAwUJcXFyLjFAGnU9uyN5Yp.xml b/resources/project/root/NmGqIpAwUJcXFyLjFAGnU9uyN5Yp.xml new file mode 100644 index 0000000..8288be5 --- /dev/null +++ b/resources/project/root/NmGqIpAwUJcXFyLjFAGnU9uyN5Yp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/root/fjRQtWiSIy7hIlj-Kmk87M7s21kp.xml b/resources/project/root/fjRQtWiSIy7hIlj-Kmk87M7s21kp.xml new file mode 100644 index 0000000..28c5d83 --- /dev/null +++ b/resources/project/root/fjRQtWiSIy7hIlj-Kmk87M7s21kp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/root/qaw0eS1zuuY1ar9TdPn1GMfrjbQp.xml b/resources/project/root/qaw0eS1zuuY1ar9TdPn1GMfrjbQp.xml new file mode 100644 index 0000000..dad7a3c --- /dev/null +++ b/resources/project/root/qaw0eS1zuuY1ar9TdPn1GMfrjbQp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/rootp.xml b/resources/project/rootp.xml new file mode 100644 index 0000000..1c0844e --- /dev/null +++ b/resources/project/rootp.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/resources/project/uuid-f48858bf-55e4-48a3-bbd2-ec2c4dc42888.xml b/resources/project/uuid-f48858bf-55e4-48a3-bbd2-ec2c4dc42888.xml new file mode 100644 index 0000000..1c0844e --- /dev/null +++ b/resources/project/uuid-f48858bf-55e4-48a3-bbd2-ec2c4dc42888.xml @@ -0,0 +1,2 @@ + + \ No newline at end of file diff --git a/sensor.slx b/sensor.slx new file mode 100644 index 0000000..89fa03e Binary files /dev/null and b/sensor.slx differ diff --git a/sensor_defs.m b/sensor_defs.m new file mode 100644 index 0000000..ff480e3 --- /dev/null +++ b/sensor_defs.m @@ -0,0 +1,3 @@ +%% temperature sensors +tauTemp = 15; % seconds +[sA,sB,sC,sD] = tf2ss([1],[tauTemp 1]); \ No newline at end of file diff --git a/slprj/sim/varcache/top_system/checksumOfCache.mat b/slprj/sim/varcache/top_system/checksumOfCache.mat new file mode 100644 index 0000000..c01660a Binary files /dev/null and b/slprj/sim/varcache/top_system/checksumOfCache.mat differ diff --git a/slprj/sim/varcache/top_system/tmwinternal/simulink_cache.xml b/slprj/sim/varcache/top_system/tmwinternal/simulink_cache.xml new file mode 100644 index 0000000..85945bf --- /dev/null +++ b/slprj/sim/varcache/top_system/tmwinternal/simulink_cache.xml @@ -0,0 +1,6 @@ + + + + TrSK5svYOodUIpqtZ/FM1A== + + \ No newline at end of file diff --git a/slprj/sim/varcache/top_system/varInfo.mat b/slprj/sim/varcache/top_system/varInfo.mat new file mode 100644 index 0000000..841a096 Binary files /dev/null and b/slprj/sim/varcache/top_system/varInfo.mat differ diff --git a/top_script.m b/top_script.m new file mode 100644 index 0000000..1076c65 --- /dev/null +++ b/top_script.m @@ -0,0 +1,16 @@ +%% initialization script +%heat_sink_defs_DEBUG +heat_sink_defs +fan_defs +sensor_defs +%% sweep +mdl = 'top_system'; +load_system(mdl); +nSims = 6; +in(1:nSims) = Simulink.SimulationInput(mdl); +for i = 1:nSims + in(i) = setBlockParameter(in(i),[mdl '/Heat Generation'], ... + 'ActiveScenario', ['Scenario' num2str(i)]); +end +out = parsim(in,'TransferBaseWorkspaceVariables','on'); +openSimulationManager(in,out) diff --git a/top_system.slx b/top_system.slx new file mode 100644 index 0000000..d1b67ec Binary files /dev/null and b/top_system.slx differ diff --git a/top_system.slxc b/top_system.slxc new file mode 100644 index 0000000..c32c800 Binary files /dev/null and b/top_system.slxc differ