Skip to content
Snippets Groups Projects

Compare revisions

Changes are shown as if the source revision was being merged into the target revision. Learn more about comparing revisions.

Source

Select target project
No results found

Target

Select target project
  • CyclotronResearchCentre/Public/fasst/mrs-gaba-nmm
  • ipaparella/mrs-gaba-nmm
2 results
Show changes
Showing
with 554 additions and 0 deletions
%% CODE TO CREATE GCM - GIT
% This code needs the usual your_paths.txt file.
% Once the NMM model is run, this code
% will create a GCM file to input in the PEB analysis.
%-----------------------------------------------------------------------
% Written by I. Paparella
% Cyclotron Research Centre, University of Liege, Belgium
% 14th December 2023
function Create_GCMs
%% Path info
paths_txt = fileread('your_paths.txt') ;
paths_txt = char(strsplit(paths_txt, '\n')) ;
pathtodata = (strtrim(paths_txt(2,:)));
%% Pre define variables
GCM = [];
%% Select the subject to analyse
cd(pathtodata);
[subdir] = spm_select(Inf,'dir','Select subject_ID directory');
IDs = str2num(subdir(:,end-2:end));
%% Loop across subjects
for isub = 1:size(subdir,1)
subject_ID = sprintf('sub-%03d', IDs(isub));
subject_Path = strcat (pathtodata, '/', subject_ID, '/TMS_EEG');
% Go in the session folder and load DCM
DCMfile_sess=spm_select('List',subject_Path,'DCM_DefaultCodes_.*.mat$');
if isempty(DCMfile_sess)
warning('No DCM for subject %s, session %s was found. Please check the subjects you selected', subject_ID, session)
return
end
Loaded_DCMfile_sess = load(strcat(subject_Path, '/', DCMfile_sess));
% Fill the GCM according to the session with all subjects together
GCM = [GCM; {Loaded_DCMfile_sess.DCM}];
end
% Make PEB directory
mkdir(strcat(pathtodata,'/PEB'));
% Save GCM with the correct naming
nameTosav= 'allFemale';
GCM = GCM;
save(strcat(pathtodata,'/PEB/', sprintf('GCM_%s_%s', session, nameTosav)), 'GCM')
fprintf('GCM has been created. \n')
end
\ No newline at end of file
%% CODE TO PERFORM ADDITIONAL QC MRS ANALYSIS REQUIRED IN 1ST ROUND REV
% This code extracts QC MRS metric (linewidth, CRLB and SNR across
% participants)
% It needs;
% a "your_paths.txt" file with all the info on your paths. An example is
% provided on GIT + the fitted MRS data.
%-----------------------------------------------------------------------
% Written by I. Paparella
% Cyclotron Research Centre, University of Liege, Belgium
% 06th November 2024
%% Path info
paths_txt = fileread('your_paths.txt') ;
paths_txt = char(strsplit(paths_txt, '\n')) ;
pathtodata = (strtrim(paths_txt(2,:)));
%% Select the subject to analyse (all except 001, 007 and 011 which are males)
cd(pathtodata);
[subdir] = spm_select(Inf,'dir','Select subject_ID directory');
IDs = str2num(subdir(:,end-2:end));
%% Variables needed
%Metrics= ['SNR', 'FWHM', '%CRLB'];
Metabs ={'GABA', 'NAA', 'Cr'};
%% Initalize variables
%MRS_QC_metrics = zeros(size(subdir,1),(length(Metrics)*length(Metabs)));
MRS_QC_metrics = [];
%% Loop across subjects to analyse and get subjective parameters
for isub = 1:size(subdir,1)
% Extract path info per subject
subject_ID = sprintf('sub-%03d', IDs(isub));
subject_MRSfit = fullfile (pathtodata, subject_ID, 'MRS');
% Load .csv summary table
SubMRS= readtable(fullfile(subject_MRSfit, '/summary.csv'));
SubMRS.Metab = categorical(SubMRS.Metab); %convert to categorical
% Extract needed info
MRS_QC_metrics_Sbj = [];
for metabi= 1: length(Metabs)
MRS_QC_metrics_Sbj= [MRS_QC_metrics_Sbj table2array(SubMRS(SubMRS.Metab== Metabs(metabi), end-2:end))];
end
MRS_QC_metrics = [MRS_QC_metrics; MRS_QC_metrics_Sbj];
end
MRS_QC_metrics=array2table(MRS_QC_metrics);
IDs_table = table(IDs);
MRS_QC_metrics_full = [IDs_table MRS_QC_metrics];
MRS_QC_metrics_full.Properties.VariableNames = {'Sbj_number'; 'GABA_CRLB'; 'GABA_SNR';'GABA_FWHM';...
'NAA_CRLB'; 'NAA_SNR';'NAA_FWHM';'Cr_CRLB'; 'Cr_SNR';'Cr_FWHM'};
writetable(MRS_QC_metrics_full,fullfile(pathtodata,'MRS_QC_1stRev_AllFemale.csv'),'WriteRowNames',true);
\ No newline at end of file
%% CODE TO PERFORM ADDITIONAL QC MRS ANALYSIS REQUIRED IN 1ST ROUND REV
% This code extracts QC NMM fit metrics (R2 and correlations between
% observed and modeled data)
% It needs
% a "your_paths.txt" file with all the info on your paths. An example is
% provided on GIT + the DCM estimated.
%-----------------------------------------------------------------------
% Written by I. Paparella
% Cyclotron Research Centre, University of Liege, Belgium
% 07th November 2024
%% Path info
paths_txt = fileread('your_paths.txt') ;
paths_txt = char(strsplit(paths_txt, '\n')) ;
pathtodata = (strtrim(paths_txt(2,:)));
%% Select the subject to analyse (all except 001, 007 and 011 which are males)
cd(pathtodata);
[subdir] = spm_select(Inf,'dir','Select subject_ID directory');
IDs = str2num(subdir(:,end-2:end));
%% Initalize variables
%MRS_QC_metrics = zeros(size(subdir,1),(length(Metrics)*length(Metabs)));
R2 = [];
r = [];
modes= [1 2 3];
%% Loop across subjects to analyse and get subjective parameters
for isub = 1:size(subdir,1)
% Extract path info per subject
subject_ID = sprintf('sub-%03d', IDs(isub));
subject_DCMest = fullfile (pathtodata, subject_ID, 'TMS_EEG');
% Load DCM file
DCMfile = spm_select('List',subject_DCMest,'DCM_DefaultCodes_.*.mat$');
SubDCM=load(fullfile(subject_DCMest, '/', DCMfile(1,:)));
% Compute R2
for m = 1:length(modes)
% compute and store R2 for ERP
MSE_1 = sum(SubDCM.DCM.R{1}(:,m).^2); % for condition 1
SS_1 = sum((SubDCM.DCM.H{1}(:,m)+SubDCM.DCM.R{1}(:,m)).^2);
R2(isub,m,1) = 1-(MSE_1/SS_1);
clear MSE_1 SS_1
end
% Compute correlations between observed and modeled data
for m = 1:length(modes)
% correlation
y1 = SubDCM.DCM.H{1}(:,m)+SubDCM.DCM.R{1}(:,m);
yhat1 = SubDCM.DCM.H{1}(:,m);
r(isub,m,1) = corr(y1(:,1),yhat1(:,1),'type','Pearson');
end
end
% Convert to table and save
r=array2table(r);
R2=array2table(R2);
IDs_table = table(IDs);
QC_metrics_full = [IDs_table r R2];
QC_metrics_full.Properties.VariableNames = {'Sbj_number'; 'Mode1_r'; 'Mode2_r'; 'Mode3_r';
'Mode1_R2'; 'Mode2_R2'; 'Mode3_R2'};
writetable(QC_metrics_full,fullfile(pathtodata,'DCM_QC_1stRev_AllFemale.csv'),'WriteRowNames',true);
\ No newline at end of file
%% CODE TO RUN PEB MODEL AND TEST MRS-GABA EFFECTS
% This code needs the usual your_paths.txt file with all the info on your paths.
% An example is provided on GIT.
% This code is an authomatized script to run PEB analysis with a regressor.
% In this case we regress the MRS-derived metrics to the NMM output. We
% will just focus on the T and H output of the NMM because they store
% receptors and connections info respectively.
%-----------------------------------------------------------------------
% Written by I. Paparella
% Cyclotron Research Centre, University of Liege, Belgium
% 14th December 2023
function PEB_analysis
%% Path info
paths_txt = fileread('your_paths.txt') ;
paths_txt = char(strsplit(paths_txt, '\n')) ;
paths = [];
paths.data = (strtrim(paths_txt(2,:)));
paths.spm = (strtrim(paths_txt(4,:)));
paths.codes = (strtrim(paths_txt(8,:)));
addpath(paths.spm)
%% Define folder to store analysis into
PEB_path= strcat(paths.data, '/PEB');
%% Start the PEB analysis
% To test whether TMS-EEG and MRS GABA metrics are related we will
% conduct a PEB analysis putting the MRS derived GABA metric as regressor
% as described here: (https://en.wikibooks.org/wiki/SPM/Parametric_Empirical_Bayes_(PEB))
% First let's create a folder to store the output of this PEB analysis
PEB_MRS_NMM = strcat(PEB_path, '/PEB_MRS_NMM_FHK_AllFemale_GABA_withoutCycle');
mkdir(PEB_MRS_NMM);
% We load the GCMs
GCM_all = load(strcat(PEB_path, '/GCM_FHK_allFemale.mat'));
% Load the MRS info
MRS = load(strcat(paths.data, '/MRS_GABA_FHK_AllSubjects.txt'));
% We define a design matrix X1 with regressors:
% Mean
% MRS-derived GABA
% Interpret: as correlation (if positive = higher MRS, higher NMM; if
% negative the other way around)
% Then we create the design matrix
X1= [ones(size(GCM_all.GCM,1),1) MRS(:,2)];
X1(:,2) = X1(:,2) - mean(X1(:,2)); % mean center the 2nd column so that the
%first column can be taken as mean connectivity across subjects. If we
%don't mean center the first column will be taken as baseline
X1_labels = {'Mean_connectivity', 'MRS'};
% Fit to all DCMs from old in a single column vector:
GCM = GCM_all.GCM;
% PEB setting and Run PEB
M = struct();
M.Q = 'all';
M.X= X1;
M.Xnames = X1_labels;
[PEB ,RCM] = spm_dcm_peb(GCM, M, {'T', 'H'}); % need to set the field otherwise the
% default will be matrix A and B (set on the MRI) which we don't have in
% NMM
% Save the output in the respective folder & run BMA
save(strcat(PEB_MRS_NMM, '/PEB_MRS_NMM_FHK_allFemale_GABA.mat'),'PEB','RCM');
BMA = spm_dcm_peb_bmc(PEB);
save(strcat(PEB_MRS_NMM,'/BMA_PEB_MRS_NMM_FHK_allFemale_GABA.mat'),'BMA');
% LOO cross-validation
spm_dcm_loo(GCM,M,{'H(3,3)'}); % on IIfeedbackLoop
spm_dcm_loo(GCM,M,{'H(3,4)'}); % on II-DP connection
end
% spm_dcm_peb_review(BMA); to review results
\ No newline at end of file
%% CODE TO RUN PEB MODEL AND TEST MRS-GABA EFFECTS
% This code needs the usual your_paths.txt file with all the info on your paths.
% An example is provided on GIT.
% This code is an authomatized script to run PEB analysis with a regressor.
% In this case we regress the MRS-derived metrics to the NMM output. We
% will just focus on the T and H output of the NMM because they store
% receptors and connections info respectively.
%-----------------------------------------------------------------------
% Written by I. Paparella
% Cyclotron Research Centre, University of Liege, Belgium
% 26th February 2025
function PEB_analysis_withCycle
%% Path info
paths_txt = fileread('your_paths.txt') ;
paths_txt = char(strsplit(paths_txt, '\n')) ;
paths = [];
paths.data = (strtrim(paths_txt(2,:)));
paths.spm = (strtrim(paths_txt(4,:)));
paths.codes = (strtrim(paths_txt(8,:)));
addpath(paths.spm)
%% Define folder to store analysis into
PEB_path= strcat(paths.data, '/PEB');
%% Start the PEB analysis
% To test whether TMS-EEG and MRS GABA metrics are related we will
% conduct a PEB analysis putting the MRS derived GABA metric as regressor
% as described here: (https://en.wikibooks.org/wiki/SPM/Parametric_Empirical_Bayes_(PEB))
% First let's create a folder to store the output of this PEB analysis
PEB_MRS_NMM = strcat(PEB_path, '/PEB_MRS_NMM_FHK_AllFemale_GABA_withCycle');
mkdir(PEB_MRS_NMM);
% We load the GCMs
GCM_all = load(strcat(PEB_path, '/GCM_FHK_allFemale.mat'));
GCM_all.GCM{11,1}= []; % remove STR7T_HS_015 -> no menstrual cycle due to contracceptive pill
% Load the MRS info
subjToExclude = 15; %015 who has no cycle due to contracceptive pill
MRS = load(strcat(paths.data, '/MRS_GABA_FHK_AllSubjects.txt'));
MRS(ismember(MRS(:,1), subjToExclude),:) = [];
% Load table with cycle info
MensCycle = load(strcat(paths.data, '/MensCycle.txt'));
% We define a design matrix X1 with regressors:
% Mean
% MRS-derived GABA
% Interpret: as correlation (if positive = higher MRS, higher NMM; if
% negative the other way around)
% Then we create the design matrix
X1= [ones(size(GCM_all.GCM,1),1) MRS(:,2) MensCycle];
X1(:,2) = X1(:,2) - mean(X1(:,2)); % mean center the 2nd column so that the
%first column can be taken as mean connectivity across subjects. If we
%don't mean center the first column will be taken as baseline
X1(:,3) = X1(:,3) - mean(X1(:,3));
X1_labels = {'Mean_connectivity', 'MRS', 'Cycle'};
% Fit to all DCMs from old in a single column vector:
GCM = GCM_all.GCM;
% PEB setting and Run PEB
M = struct();
M.Q = 'all';
M.X= X1;
M.Xnames = X1_labels;
[PEB ,RCM] = spm_dcm_peb(GCM, M, {'T', 'H'}); % need to set the field otherwise the
% default will be matrix A and B (set on the MRI) which we don't have in
% NMM
% Save the output in the respective folder & run BMA
save(strcat(PEB_MRS_NMM, '/PEB_MRS_NMM_FHK_allFemale_GABA.mat'),'PEB','RCM');
BMA = spm_dcm_peb_bmc(PEB);
save(strcat(PEB_MRS_NMM,'/BMA_PEB_MRS_NMM_FHK_allFemale_GABA.mat'),'BMA');
% LOO cross-validation
spm_dcm_loo(GCM,M,{'H(3,3)'}); % on IIfeedbackLoop
spm_dcm_loo(GCM,M,{'H(3,4)'}); % on II-DP connection
end
% spm_dcm_peb_review(BMA); to review results
\ No newline at end of file
#### STR7T_HS -- CORRELATION ANALYSIS TMS-EEG DERIVED GABA MEASURES AND MRS ONES
## -------------------------------------------------------------------------------------------------------------------
## Created: Thursday Dec 21 14:37 2023 -- author: ipaparella@uliege.be
# To check citation (for referencing) for any of the package used in this script just run citation("package")
## -------------------------------------------------------------------------------------------------------------------
### WHAT IS THIS SCRIPT DOING?
## 1. Regression plots of the relationships shown by PEB analysis.
## --------------------------------------------------------------------------------------------------------------------
## --------------------------------------------------------------------------------------------------------------------
## --------------------------------------------------------------------------------------------------------------------
## --------------------------------------------------------------------------------------------------------------------
# Import Libraries
library("ggpubr")
library("tidyverse")
library("ggplot2")
library(viridis)
# Import data
GABAmetrix_onlyFem <- read.csv("/mnt/data/STR7T_HS/Prepared/STR7T_NMM_perSess_DefaultCodes_AllSubjects.txt")
### 1.
EI_MRS = GABAmetrix_onlyFem$MRS_GABA/GABAmetrix_onlyFem$MRS_GLU
data.frame(EI_MRS)
GABAmetrix_onlyFem = cbind(GABAmetrix_onlyFem, EI_MRS)
# Average of tonic and phasic inhib (just the significant values)
TonicInhib_sign = rowMeans(subset(GABAmetrix_onlyFem, select = c(SC, II, DP)), na.rm = TRUE)
PhasicInhib_sign = rowMeans(subset(GABAmetrix_onlyFem, select = c(II.DP)), na.rm = TRUE)
# Add this to table
GABAmetrix_onlyFem = cbind(GABAmetrix_onlyFem, TonicInhib_sign, PhasicInhib_sign)
# Check colors in virdis palette
# library(scales)
# v_colors = viridis(30, option = 'D') -> number means how many colors you want to see
# show_col(v_colors)
# Plots
ggplot(GABAmetrix_onlyFem, aes(x=MRS_GABA, y=GABAa)) +
geom_point(alpha=0.7, color="#3C508BFF", size = 4) +
geom_smooth(method=lm , color="#3C508BFF", fill="#3C508BFF", se=TRUE)+
theme_classic()+
xlab("GABA:Cr") +
ylab("GABAa")+
font("xy.text", size = 20, color = "black")+
scale_y_continuous(labels = scales::label_number(accuracy = 0.1))
#
GABA_MRS_Tonic = cor.test(GABAmetrix_onlyFem$TonicInhib_sign, GABAmetrix_onlyFem$MRS_GABA,
method="spearman",exact=FALSE)
GABA_MRS_Tonic
ggplot(GABAmetrix_onlyFem, aes(x=MRS_GABA, y=TonicInhib_sign)) +
geom_point(alpha=0.7, color="#1F948CFF", size = 4) +
geom_smooth(method=lm , color="#1F948CFF", fill="#1F948CFF", se=TRUE)+
theme_classic()+
xlab("GABA:Cr") +
ylab("Tonic Inhibition")+
font("xy.text", size = 20, color = "black")
#### -> 3rd round revision menstrual cycle effect. Plot linear regression with menstrual cycle category
# Create extra column with cycle factor
Cycle=c('M', 'M', 'M', 'M', 'L', 'L', 'M', 'F', 'L', 'F', 'None', 'M', 'F', 'F', 'M', 'F', 'F', 'M', 'L', 'L')
data.frame(Cycle)
GABAmetrix_onlyFem_cycle = cbind(GABAmetrix_onlyFem, Cycle)
# Plots
ggplot(GABAmetrix_onlyFem_cycle, aes(x=MRS_GABA, y=GABAa, col=Cycle)) +
geom_point(alpha=0.7, size = 4) +
geom_smooth(method=lm , color="#3C508BFF", fill="#3C508BFF", se=TRUE)+
theme_classic()+
xlab("GABA:Cr") +
ylab("GABAa")+
font("xy.text", size = 20, color = "black")+
scale_y_continuous(labels = scales::label_number(accuracy = 0.1))
#
ggplot(GABAmetrix_onlyFem_cycle, aes(x=MRS_GABA, y=TonicInhib_sign, col=Cycle)) +
geom_point(alpha=0.7, size = 4) +
geom_smooth(method=lm , color="#1F948CFF", fill="#1F948CFF", se=TRUE)+
theme_classic()+
xlab("GABA:Cr") +
ylab("Tonic Inhibition")+
font("xy.text", size = 20, color = "black")
Sbj_number,Mode1_r,Mode2_r,Mode3_r,Mode1_R2,Mode2_R2,Mode3_R2
2,0.814922555503975,0.711756698424267,0.947713403401497,0.662752604514475,0.50448606801357,0.897857212544311
3,0.791874350491316,0.905186996445252,0.66616857852364,0.626902357648098,0.815887552689512,0.440862359149716
4,0.81011230920811,0.886246173596499,0.967352644495842,0.6549819892586,0.785247363371429,0.9354721869336
5,0.862267348517587,0.973618616153802,0.947306982789012,0.743503828854095,0.947896907440254,0.897092983027956
6,0.0128485839337502,0.997498438339493,0.381051333452898,-6.57393748666468e-05,0.994977330002448,0.140278050346107
8,0.164937867912563,0.974405638758539,0.98922523447755,0.0133302844856542,0.949173563410989,0.978480863653342
9,0.992842315142799,0.902129314649765,0.749791525935589,0.985449234741821,0.812685608868223,0.559075597871756
10,0.973761878496147,0.902568306038386,0.526929891338071,0.948150344951642,0.814079553697573,0.276642161323963
13,0.991277308412225,0.908348620509626,0.794014437691387,0.98253722389758,0.823517419160016,0.630031645932489
14,0.858485264260853,0.698665545533499,0.817232074255248,0.732451490706415,0.487927117184329,0.664870746020384
15,0.872503571690131,0.754255862955138,0.357190823558097,0.761003693923247,0.567949404610925,0.127585258265384
16,0.882101926935536,0.911651013735556,0.696833527903331,0.773528202254237,0.830843194276447,0.48332024268214
17,0.787816120889158,0.821848908745289,0.507799148587271,0.615345292659244,0.672037545711244,0.257708494652129
18,0.905652582422717,0.806570448781514,0.315401946916528,0.816680329354101,0.642894398246837,0.0867423182547586
19,0.984457201139293,0.409117962449408,0.504437324989044,0.969049108699665,0.152073854779756,0.254123351438169
22,0.987069426877106,0.629304114946009,0.785086648207074,0.97430553054976,0.396022279873925,0.616030328045843
23,0.977381942008066,0.840537792747338,0.901372126625464,0.954134353886452,0.693745851868254,0.811644308630754
25,0.870752399609215,0.89589679548134,0.936294671198279,0.746978713628694,0.794881438708092,0.871669333881875
27,0.469599886265455,0.802487151872052,0.874050551956511,0.214502687334372,0.637169166409,0.763940714018192
29,0.72332186983215,0.57358947478923,0.269839206979976,0.517665350718404,0.319469111278032,0.062076651668484
2,0.25
3,0.19
4,0.14
5,0.18
6,0.11
8,0.18
9,0.13
10,0.13
13,0.12
14,0.16
15,0.2
16,0.16
17,0.21
18,0.24
19,0.26
22,0.14
23,0.15
25,0.14
27,0.18
29,0.18
Sbj_number,GABA_CRLB,GABA_SNR,GABA_FWHM,NAA_CRLB,NAA_SNR,NAA_FWHM,Cr_CRLB,Cr_SNR,Cr_FWHM
2,15.8862900670778,16.5906485640953,20.8675927417006,1.99446530537243,319.777172181749,9.24858124980953,9.01936612888647,107.01130642899,9.13915765231335
3,21.6523244317244,16.5271394470785,20.2408488306069,2.029624787034,403.804770928853,8.46578352618539,6.19641029807787,140.195411708271,8.4826432723526
4,19.9134580113918,11.7864632500804,21.4671139180831,1.89884365636381,376.350101796133,10.4413111676182,5.85524982803749,134.251610386046,10.1222100566541
5,19.7441327542206,9.27473666306194,23.5446277069085,1.91702553961148,192.674217394942,11.7010788340367,6.36068941124869,76.3931026165363,11.4245882339275
6,28.4223580185404,10.3934927507174,21.5809700362744,1.53123594197878,369.684083907281,10.3715638472458,6.08899652772495,137.885050760104,9.98088562968319
8,15.6870496868217,15.9039226202407,21.427536103362,1.88018865459646,369.971105056835,9.99692979362318,9.16010081853414,142.403301019926,9.62768245511254
9,23.363662134186,12.305830839555,22.8463440768853,1.8920136111316,368.042501723021,12.8863612317523,7.09956795495761,156.229083993389,12.6276912685552
10,36.7143492112344,11.3553848655574,22.4443578770775,2.16386826673786,336.125036850124,11.1097953606126,7.38696097238393,125.373652046031,10.7991591105018
13,23.9846596318942,10.2608435023034,21.0345363074404,1.82853468942681,365.623995326374,9.12252729579927,6.80326460936619,131.229582483236,9.13292006426626
14,27.2854692484648,14.1388382790066,23.1378440014119,2.3267610750328,399.150640674152,12.0082557757244,8.45701626798235,146.365249891675,11.6575840349274
15,20.4684569637125,18.8124413774159,20.2289365341515,1.95312766837789,440.381055951918,8.82129122856652,6.46815144024494,149.44691622135,8.82503784124411
16,18.8401462459997,7.64511976573976,20.1151087030315,1.61823898526216,225.879105566529,8.60510942981095,4.34068574925177,83.9560313750975,8.61397328821435
17,14.9897470258016,10.3044664598522,21.7366720279935,1.95565302031826,220.509817706297,10.611416278347,5.11947464887352,74.6504735267009,10.2111806744513
18,19.2671695556443,20.0241013400042,21.9020461378007,2.30350555219652,369.754855633364,9.7122688162964,9.82628282618213,124.326295373124,9.80065757562655
19,11.9842454255188,10.6594357926219,20.4266837763072,1.32699780606338,198.693346040064,8.63262878369464,7.02554396747565,65.4482346274129,8.64316771708372
22,23.4957119446681,13.0581551875335,21.6388138477321,1.71981653010845,390.525520296684,9.50544945268503,7.12852692650114,152.580051944091,9.56595622264721
23,18.477774163411,7.35762104370389,20.1834192696835,1.74173115372408,251.872190347498,8.52840652522201,6.57883837080297,84.0081519713456,8.55150889248554
25,34.3132437802341,7.66792018976849,22.5745320687148,3.0485561980004,233.893791148461,11.3527542643982,7.5740532007385,84.7151100406179,11.2792889335243
27,30.5308723922225,11.1504730260624,21.6492308449757,3.57658451181303,268.101976394358,10.6616488738083,13.2772375265084,92.9916170605851,10.265819190848
29,14.3565016017468,10.9337870219807,20.2135368743212,1.34502021075701,299.84421500941,8.56127029517265,5.36311630720128,104.163440421517,8.57361761388005
2,0.0
3,10.7
4,17.9
5,3.6
6,67.9
8,64.3
9,17.9
10,28.6
13,71.4
14,39.3
16,21.4
17,32.1
18,25.0
19,21.4
22,39.3
23,35.7
25,3.6
27,82.1
29,71.4
File added
File added
File added
File added
File added
Sbj_number,Session,SC,SC-SP,SC-II,SP,SP-DP,II-SC,II-SP,II,II-DP,DP-SP,DP,AMPA,GABAa,NMDA,Cl-,Na2+,Ca2+,K-,Background,Mean_field,TonicInhib,PhasicInhib,MRS_GABA,MRS_GLU,EIratioAll,EIratioReceptors
2,1,0.62849120490948,-0.138414279453878,-0.0440484478037346,0.0551553036957765,0.0192295060574423,-0.000483660257266389,0.212007379674699,-0.0265193871753135,-0.00816427906433522,0.036908667133347,-0.213630679849515,0.245507143276337,0.28782822645242,-0.00610079565592248,0.856100715521665,-1.2833380483356,-0.00114095026212257,-0.198265512613431,0.182626414365983,-0.474427613416869,0.110874110395107,0.067786480117699,0.25,1.13,-0.329683994419921,0.0484218788320052
3,1,-0.304355660092636,0.335947982149504,-0.177623863111284,-0.507772551446001,0.136411132587554,-0.13646034610294,0.199082102534659,0.0653041032657374,0.0019952491952722,0.0880226023275463,-0.180719735263965,-0.0141739621389767,0.285825145730714,-0.043886800999405,2.11998631333935,-1.88209105601666,-0.059389307395252,0.13746475813981,0.475697475331887,-0.0390049611367119,-0.231885960884216,0.0215390018756636,0.19,1.18,0.318140848326329,0.343885908869096
4,1,0.305457351552587,0.217758435111866,-0.0876143780972275,0.168140003933831,-0.0424221085053871,-0.194480221775372,-0.0251634030079029,0.140416325490297,0.00496449181284441,-0.0141451353439868,-0.0509202720116254,-0.115054888708954,-0.0336650865459864,0.0125618412839542,-1.38477555971668,-0.180406051500435,-0.0572135955074755,0.0206159785136399,0.211933420814597,-0.122828341435662,0.140773352241272,-0.0715597109901434,0.14,1.08,0.288255946135695,0.0688279608790134
5,1,-0.261372952629521,-0.0591475394255927,-0.0737388463294938,0.321188871803954,-0.0174082248430952,-0.105682178589235,0.181887930652927,0.29643880635976,0.0194892451892985,0.0699940377762039,-0.119460538434886,-0.370222872877308,-0.410336981442966,-0.0187693526806674,-0.868143655575744,-0.930303486783681,-0.626742502176769,-0.0248711285615721,0.501037638013424,-0.0435997023295339,0.059198546774827,0.0318983324176632,0.18,0.92,-0.175995570074968,-0.0213447558849907
6,1,-0.0472195281288689,-0.115071460612264,0.0950035244931984,-0.0733501600401941,-0.00625700829620379,-0.0197035496638596,0.00260103505067049,-0.323574049590964,0.0138621045515224,0.232994559300038,-0.184635411752515,-0.0499191167172563,0.266162159112241,-0.00872164741467105,0.604922466441742,1.02303099278449,-0.998695682926139,-0.165991781626748,0.141322774395977,0.134006917438358,-0.157194787378135,-0.00108013668722226,0.11,0.91,0.209910024946435,0.324802923244169
8,1,-0.261295545856732,0.10072470345828,0.222439852887601,-0.330286057466155,-0.395300407197077,-0.101464977957687,-0.0935145289988295,0.225394906804417,0.221036935550767,-0.0671422287017641,0.623906480662427,-0.56914211288263,0.479415056986024,-0.00851084034618196,0.706980727756525,1.16309663230477,0.307383447077691,-0.440196199906683,-0.182984652777996,-0.694523979898307,0.064429946035989,0.00868580953141714,0.18,1.13,-0.165335508147211,1.05706801021484
9,1,-0.445048873434144,-0.337917570208812,0.185441846513175,0.67183506799055,0.0324210148115867,-0.0300649686892324,0.129567229512789,-0.309859648102614,0.0072354554551424,0.000291026135472132,0.0227271955098717,-0.160982697322197,0.272207649397452,0.000754038295319586,-0.554432842498028,-0.60371356935868,0.2147081469504,0.026679889668429,0.376831210766135,-0.096889433243957,-0.015086564509084,0.0355792387595663,0.13,1.02,-0.226501399027277,0.432436308424329
10,1,-0.447301393918209,0.18002950945936,0.0653965088060833,-0.216534261156869,-0.0375948569487784,0.296614562938962,0.076707735412654,-0.0248679149287169,-0.00410246254162153,-0.0227773982897067,0.000835906769178676,-0.282240402024102,-0.484725137539154,-0.12791620160436,-0.799177914175009,-1.12859515034464,0.214084237164703,-0.0163028866502493,0.605346823261885,-0.219605338922933,-0.171966915808654,0.123073278603331,0.13,1.03,-0.184166072783036,-0.0745685339106917
13,1,-0.274110866729871,-0.22203195219537,0.0819063938708748,0.41720286728001,0.417918676174208,-0.0400122906488619,0.0674233253858721,-0.0952003334954348,-0.000805674698552484,0.0241585879904191,-0.503248974276957,-0.160385603822083,0.318544043090685,-0.0110553859316153,-0.286297955492904,-0.970651535770336,0.017391873740892,0.623879714141887,0.282778467307903,-0.0851986300393726,-0.113839326805563,0.00886845334615259,0.12,1.06,0.275346345801674,0.489985032844383
14,1,-0.761608202383256,0.119452776061409,-0.154552037803013,0.315931566988621,0.0209559143671828,-0.192832668897052,0.463890198797304,0.293608200828408,0.0103095420616019,0.0199416620189957,-0.0983093966892613,-0.237840410358011,-0.453635952374018,-0.0755857353800113,-0.843468688210843,-0.903817026192906,-0.119124526797723,0.0365705332126515,0.715917112195507,-0.319684036012091,-0.0625944578138718,0.0937890239872849,0.16,1.05,-0.27556875731728,-0.140209806635996
15,1,0.0995010718195936,-0.00586310890729742,0.0212194471893977,0.141161286617558,0.00435162126938885,0.0251339916084492,0.0263702446324677,-0.0231072911949059,-0.000459592856849525,0.00558666853039356,-0.00510991716365449,-0.230438041307481,-0.118535013693065,0.00655843431140826,-0.213114324779944,-0.284293674948655,-0.015308762793928,5.38173579219381e-05,0.238482295909057,0.0247592502927472,0.0531112875196479,0.0170148811280224,0.2,1.04,-0.0257500153021846,0.105344593303008
16,1,-0.0353610446413792,-0.0910468250246454,0.0382026288932682,0.170917931912406,0.0195289544810109,-0.00488398251576028,0.00676541439344311,-0.0509935582655706,0.00063512799174723,0.000791618422827901,0.00734888817079924,-0.18431234841517,0.000690949085867466,0.00255067638603313,-0.0781106116677097,-0.419411759170021,0.0286054897414109,0.00777113673051495,0.341759628638731,0.162019524974915,0.0229780542940638,0.00083885328981002,0.16,1.03,-0.0350401830969684,0.182452621115005
17,1,0.190561879355764,-0.119159033833404,0.0819486030138241,0.227469509710298,0.325682159645898,0.042154187988947,-0.00461473253845101,-0.261288899882802,-0.0164884656239012,0.151227460647103,-0.322854328166596,-0.172564835934257,0.480157284677863,-0.0168680759517395,0.651118687220128,-1.13623073133832,-0.0534319296538643,-0.0875916230335349,0.0519446360064948,-0.179633459118907,-0.041527959745834,0.00701699660886495,0.21,1.24,0.418648199646826,0.66959019656386
18,1,-0.277178552737152,0.308516642264668,-0.0762515171825618,-0.386715505841062,-0.0158338945723693,-0.0830260768782456,-0.0722070459556065,0.0999794136470779,0.00245261764748901,-0.0148572083936232,-0.0219626605636406,0.396067145670877,0.309933869404045,-0.0285366935153102,0.057628533125814,0.669698426871041,0.0111438444364682,0.0361780579558945,-0.134681410466497,-0.272257958791988,-0.146469326373694,-0.050926835062121,0.24,1.02,0.354354527302477,-0.0575965827515219
19,1,-0.449450349353352,-0.660001927356098,-0.0957420020394401,0.246028764986159,-0.0391347216195628,-0.209332037180464,0.153432277013059,0.0740429182090301,-6.75950933842903e-05,0.139763788028787,-0.119201121523266,-0.517100721923317,-0.0761710723052734,-0.015858537453094,-0.276002533550913,1.14823701104346,-1.06246480321322,-0.166300530035404,0.666667382077734,-0.37035943782769,-0.0621449469203571,-0.0186557850869297,0.26,1.11,-0.599147507725524,0.456788187071138
22,1,-0.193628488976359,-0.344051202697034,0.487151033122354,0.240558858948666,-0.274865102797665,-0.0855003286282752,0.130546147131461,-0.669823876817213,0.496597863575775,0.336509121885616,-0.346922291851889,-0.168552519958002,0.11932667967638,-0.0117262025130073,0.804496492227982,1.0557762809636,-1.52937987129364,0.151671478190639,0.0353184509212831,0.0774913421722536,-0.242453949674199,0.18054789402632,0.14,1.04,-0.33689983256569,0.29960540214739
23,1,-0.125200086900711,-0.280593801945131,0.391348050458872,0.253699072826608,0.0346128161625889,-0.0754023393075929,0.077979510906235,-0.431693648913267,-0.00443847981564331,0.278030834929462,-0.308747424496198,-0.100056858962799,0.130136034098465,-0.0118394275453279,0.6821432765955,0.522030401477068,-1.47343515358187,0.0374795912753665,0.202945832123907,0.0665452469429097,-0.152985521870892,-0.000620436072333762,0.15,1.01,0.425259207822794,0.242032320606592
25,1,-0.13993271396886,-0.129108670407599,-0.00292389908336232,0.247387476264248,-0.0420129402949807,-0.10837903421192,0.0227419396684176,0.212002602262727,-0.00611632363489249,-0.0125713453115433,0.00658617398843733,-0.239686330631624,-0.15662491941331,-0.00829042027809129,-1.03837634788608,-1.06053738511553,-0.238268268980116,-0.155609806570722,0.625432365822769,-0.0366045531495932,0.0815108846366382,-0.0305844727261317,0.14,1.01,-0.0948634369190904,0.0913518314964049
27,1,-0.225525906698601,0.2276942569362,-0.0650717778800147,-0.315436801528786,-0.00976041321762754,-0.108315818899353,-0.110278213294756,0.112576186889959,0.000914124267452188,-0.0172265545351372,0.0247544049955526,0.0536237517244153,0.132970982378578,-0.0209598916109836,0.888898763788058,-0.094575601457008,0.0971051767624842,-0.026242237185548,0.0490364610926646,-0.370539507922951,-0.100908029085469,-0.0725599693088857,0.18,1.09,0.353315419230078,0.100307122265147
29,1,-0.0449370922931282,0.661756144354998,0.0325583271479706,-0.506885132598731,-0.00490089890991147,0.0521840508501117,0.0115992055649468,0.0967566046177922,0.0018992337225158,-0.00870443678529473,0.00336444485640436,0.234566329915841,-0.319543021897056,-0.0477651915177179,-0.786119116330966,0.729083272546685,-0.141507773422004,0.00706697716195041,-0.122684314360296,-0.57900993716649,-0.112925293854416,0.0218941633791914,0.18,1.1,0.615026645670188,-0.506344160295179