Browse Source

new analysis with the ARX model

strongway 1 year ago
parent
commit
5102303e08

+ 3 - 3
README.md

@@ -1,7 +1,7 @@
 
-# Data and codes for the study of Predictive coding in ASD
+# Duration Reproduction Dataset in high/low Volatility for ASD and TD individuals
 
-authors: Z. Shi, L. Theisinger, F. Allenmark, R. Pistorius, H. Müller, C. Falter-Wagner
+authors: Z. Shi, F. Allenmark, L. Theisinger, R. Pistorius, S. Glasauer, H. Müller, C. Falter-Wagner
 
 ## Folder Structure
 
@@ -16,5 +16,5 @@ This sub-folder contains Matlab codes and instructions for the duration reproduc
 
 3. `/figures`: store figures used in the paper. 
 
-4. `analysis-notebook.rmd`: the main analysis code and report
+4. `analysis-notebook.ipynb`: the main analysis code and report
 

+ 0 - 675
analysis-notebook.Rmd

@@ -1,675 +0,0 @@
----
-title: "Data Analysis of Predictive coding in ASD"
-author: "Z. Shi, L. Theisinger, F. Allenmark, R. Pistorius, H. Müller, C. Falter-Wagner"
-output: html_notebook
----
-
-# Data Structure
-
-1. `/experiments`: Experimental codes and instructions
-
-This sub-folder contains Matlab codes and instructions for the duration reproduction task. The sequences of the duration reproductions are stored in the sub-folder `/experiments/seqs`. Those sequences were used for matched participants. 
-
-2. `/data`: raw data files
-
-- `rawdata.csv`: Raw reproduction trials
-- `outliers.csv`: those produced almost flat reproduction
-
-3. `/figures`: store figures used in the paper. 
-
-# Data Analysis
-
-## 1. load raw data
-```{r packages, message=FALSE, warning=FALSE, include=FALSE}
-# load packages
-library(tidyverse)
-library(ez)
-library(cowplot)
-library(BayesFactor) # in case need Bayes factor analysis
-library(bayestestR)
-library(rstatix) # using tidyverse friendly statistics
-library(GGally)
-
-# ---- read data and preparation -----
-rawdata = read_csv('./data/rawdata.csv') 
-rawdata$group = toupper(rawdata$group)
-# flag
-saveFig = FALSE
-```
-
-Show the raw trial structure: 
-```{r raw trial structure}
-glimpse(rawdata)
-
-```
-In the raw trials, there are several important columns which are relevant for  further analyses. 
-
-- `Duration`: The test durations generated by computer. 'pdur' is the actual presented durations by the computer. There were some fluctuations, but within 5 ms (within 1 refresh frame). 
-- `sub`, `group`, `sequence` are anonymized subject number, group and the duration sequence used in the experiment. 
-- `Reproduction`, `rep_err`: the reproduced durations and the reproduction errors compared to the given duration. 
-- `itd`, `preDuration`: the inter-trial difference in  a given trial, and the duration used in the previous trial. These were used in the sequential effect analysis. 
-
-### Participants
-
-```{r participants}
-# Total participants
-print(length (unique(rawdata$sub)))
-# total sequences (pairs)
-print(length(unique(rawdata$sequence)))
-```
-
-## The sampled durations and sequences
-
-Let's first illustrate the sequence and the distribution of the sample durations. 
-
-```{r sequence}
-# ---- illustrate one sequence -----
-fig11 = ggplot(rawdata, aes(Duration)) + geom_histogram(binwidth = 0.1, fill = I("white"), col = I('black')) + 
-  theme_classic() + xlab('Duration (secs)')
-
-# a typical sequence
-sub1 = rawdata %>% filter(sub == 'ara27')
-fig12 = ggplot(sub1, aes(trlNo, Duration, color = Volatility)) + geom_line() + 
-  xlab("Trial Sequence") + theme_classic()+
-  theme(legend.position = 'top')
-
-# histogram of the typical sequence
-
-fig13 = ggplot(sub1, aes(y=Duration, color = Volatility)) + geom_density() + theme_classic() + theme(legend.position = 'top')
-fig13
-
-fig1 = plot_grid(fig12,fig13, rel_widths =c(3,1))
-fig1 
-if (saveFig){
-  ggsave("figures/fig_sequence.png", fig1, width=4, height=3.5)
-  ggsave("figures/fig_sequence.pdf", fig1, width=4, height=3.5)
-}
-```
-
-
-## Explorative data analysis and outlier detection
-
-We first estimate two key signatures - the central tendency index (ci) and the sequential dependence index (si). 
-
-```{r linear_models}
-# using error for regression, -slope is the central tendency index. 
-ct_model <- function(df){
-  lm(rep_err ~ Duration, data = df)
-}
-
-# sequential effect using the duration from the previous trial
-seq_model <- function(df){
-  lm(rep_err ~ preDuration, data = df)
-}
-
-# exclude extreme trials (beyond [1/3D, 3D])
-vdata = rawdata %>% 
-  filter(Reproduction > Duration/3, Reproduction < 3*Duration) 
-
-# calculate slope for the central tendency as well as the sequential dependence. 
-slopes_ct <- vdata %>% group_by(sub, sequence, Volatility, group, Order) %>%
-  nest()  %>%  # nested data
-  mutate(model = map(data, ct_model)) %>%  # linear regression
-  mutate(slope = map(model, broom::tidy)) %>%  # get estimates out
-  unnest(slope, .drop = TRUE) %>% # remove raw data
-  select(-std.error,-statistic, -p.value) %>%  # remove unnecessary columns
-  spread(term, estimate) %>%   # spread estimates
-  rename(intercept_ct = `(Intercept)`, slope = Duration) %>%
-  select(-data, -model)
-
-#sequential effect
-slopes_seq <- vdata %>% filter(!is.na(preDuration)) %>%
-  group_by(sub, sequence, Volatility, group, Order) %>%
-  nest()  %>%  # nested data
-  mutate(model = map(data, seq_model)) %>%  # linear regression
-  mutate(slope = map(model, broom::tidy)) %>%  # get estimates out
-  unnest(slope, .drop = TRUE) %>% # remove raw data
-  select(-std.error,-statistic, -p.value) %>%  # remove unnecessary columns
-  spread(term, estimate) %>%   # spread estimates
-  rename(intercept_seq = `(Intercept)`, seq_slope = preDuration) %>% 
-  select(-data, -model)
-
-# merge two tables together
-slopes_all = left_join(slopes_ct, slopes_seq, 
-                       by = c("sub", "sequence", "Volatility","group","Order")) %>% 
-  mutate(ci = -slope, si = seq_slope)  #central tendency index
-
-# estimated general biases (over-/under-estimates)
-
-# individual mean interval (middle point): most of them were around 1 by design
-mInterval  = vdata %>% group_by(sub) %>%  summarise(mDur = mean(Duration))
-
-# join the mean interval, and estimate the general bias
-slopes = slopes_all %>% left_join(., mInterval, by = c('sub')) %>% 
-  mutate(gBias = (intercept_ct + slope * mDur)*1000)
-
-# change factor order for plotting
-slopes$Volatility = factor(slopes$Volatility)
-slopes$Order = factor(slopes$Order)
-slopes$group = factor(slopes$group)
-
-head(slopes)
-```
-
-Let's plot the histograms of the central tendency index and the sequential dependence index, which show some outliers. We visualize the outliers using 3-sigma rule. The 3-sigma rule only rule out 0.3% of the population if we assume the population is normal. 
-
-```{r}
-ci_3sig = mean(slopes$ci) + c(-1,1)*3*sd(slopes$ci)
-si_3sig = mean(slopes$si) + c(-1,1)*3*sd(slopes$si)
-
-hist1 = ggplot(slopes, aes(x = ci, y = ..density..)) + 
-  geom_histogram(colour = 1, fill = 'white', bins = 20)  + 
-  geom_vline(xintercept = ci_3sig, linetype = 'dashed', color = 'red') +
-  theme_classic() + xlab('Central Tendency Index')
-hist2 = ggplot(slopes, aes(x = si, y = ..density..)) + 
-  geom_histogram(colour = 1, fill = 'white', bins = 20)  + 
-    geom_vline(xintercept = ci_3sig, linetype = 'dashed', color = 'red') +
-  theme_classic() + xlab('Sequential Dependence Index')
-
-hist_fig = plot_grid(hist1,hist2, nrow = 2)
-hist_fig
-if (saveFig){
-  ggsave("figures/hist_fig.png", hist_fig, width=4, height=3.5)
-  ggsave("figures/hist_fig.pdf", fig1, width=4, height=3.5)
-}
-
-```
-
-Note, the above outlier detection method is agnostic to the groups and conditions!
-
-Let's find out those outliers and exclude by sequences for further analyses (given that ASD and TD groups were paired). 
-
-```{r}
-slopes %>% ungroup() %>% filter(ci > ci_3sig[2] | ci < ci_3sig[1] | si > si_3sig[2] | si < si_3sig[1]) %>% select(sequence) -> outlier_seq
-outlier_seq$sequence
-```
-
-Now let's visualize the outliers together with their matched pairs. 
-
-```{r outliers}
-# ---- plot  outliers  ----
-fig_outlier = rawdata %>% ungroup() %>% filter(sequence %in% outlier_seq$sequence) %>% 
-  filter(Reproduction > Duration/3, Reproduction < 3*Duration) %>% 
-  group_by(sub, group,sequence, Volatility, Duration) %>%
-  summarise(mRep = mean(Reproduction), sdr=sd(Reproduction), n = n(), 
-            se = sd(Reproduction)/sqrt(n-1)) %>% filter(n>5) %>% #approx. for linear regression without averaging first
-  ggplot(aes(Duration, mRep, color = group, 
-             group = interaction(group, Volatility), 
-             shape = Volatility, linetype = Volatility)) + 
-  geom_point()  + geom_smooth(method = 'lm', se = FALSE) + 
-  facet_wrap(~sequence, ncol = 4) +
-  theme_classic() + theme(legend.pos = 'bottom') +
-  geom_abline(slope = 1, linetype = 3) + 
-  xlab('Duration (Secs)') + ylab(' Reproduction (Secs)') + 
-  theme(strip.background = element_blank(), strip.text.x = element_blank())
-fig_outlier
-if (saveFig){
-  ggsave("figures/fig_outlier.png", fig_outlier, width=5, height=5)
-  ggsave("figures/fig_outlier.pdf", fig_outlier, width=5, height=5)
-}
-```
-Mean slopes and related statistics:
-
-```{r}
-slopes %>% filter(sequence %in% outlier_seq$sequence) %>% arrange(group, Volatility)
-vslopes = slopes %>% filter(!(sequence %in% outlier_seq$sequence))
-
-# outliers
-oslopes = slopes %>% filter(sequence %in% outlier_seq$sequence)
-
-# ANOVA
-ezANOVA(data = oslopes, dv = ci, 
-                 wid = sub, 
-                 within = Volatility,
-                 between = group)
-
-```
-### Outliers and sequential dependence
-
-Visualize the strong sequential dependence. 
-
-```{r}
-fig_sdep31 = rawdata %>% filter(sequence %in% c(31) ) %>% # the extreme sequential dependence pair
-  mutate_at("preDuration", round, 1) %>%
-  group_by(sequence, group, preDuration) %>% 
-  summarise(rep_err = mean(rep_err)) %>% 
-  ggplot(aes(preDuration, rep_err, color = group) ) + 
-    geom_point() + geom_smooth(method = 'lm') + theme_classic() + 
-    geom_abline(slope = 0, linetype = 2) + 
-#  facet_wrap(~sequence) +
-    xlab('Duration trial n-1') + ylab('Repr. Error (Secs)') + 
-  theme(strip.background = element_blank(), strip.text.x = element_blank(), legend.position = 'bottom') 
-fig_sdep31
-
-fig_o = plot_grid(fig_outlier, fig_sdep31, nrow = 1, labels = c('a','b'), rel_widths = c(2.4,1))
-if (saveFig){
-  ggsave("figures/fig_o.png", fig_o, width=7, height=3)
-  ggsave("figures/fig_o.pdf", fig_o, width=7, height=3)
-  
-}
-
-
-```
-
-## Typical reproduction performance 
-
-And here are the two typical participants produced errors from sequence 12:
-```{r typical participants}
-# ---- reproduction figure - an example -----
-# mean analysis
-mrep = rawdata %>% ungroup() %>% filter(!(sequence %in% outlier_seq$sequence)) %>% 
-  filter(Reproduction > Duration/3, Reproduction < 3*Duration) %>% 
-  group_by(sub, group,Order, sequence, Volatility, Duration) %>%
-  summarise(mRep = mean(Reproduction), sdr=sd(Reproduction), n = n(), 
-            se = sd(Reproduction)/sqrt(n-1)) %>% filter(n>3)
-
-# individual examples
-# asd
-fig_asd = mrep%>% 
-  filter( sequence == '11', group == 'ASD') %>% 
-  ggplot(aes(Duration, mRep, color = Volatility, group = Volatility, shape = Volatility)) + 
-  geom_point(size = 2) + 
-  #geom_line(aes(linetype = Volatility)) + 
-  geom_smooth(method = 'lm', aes(fill = Volatility), se = FALSE) +
-  geom_errorbar(aes(ymin = mRep - se, ymax = mRep +se), width = 0.05) + 
-  theme_classic() + theme(strip.background = element_blank()) +
-  geom_abline(slope = 1, linetype = 2) + 
-  theme(legend.position = 'none', plot.margin = unit(c(0,0,0,0),'cm')) +
-  ylab('') + xlab('')
-
-#td
-fig_td = mrep%>% 
-  filter( sequence == '11', group == 'TD') %>% 
-  ggplot(aes(Duration, mRep, color = Volatility, group = Volatility, shape = Volatility)) + 
-  geom_point(size = 2) + 
-  geom_smooth(method = 'lm', aes(fill = Volatility), se = FALSE) +
-  geom_errorbar(aes(ymin = mRep - se, ymax = mRep +se), width = 0.05) + 
-  theme_classic() + theme(strip.background = element_blank()) +
-  geom_abline(slope = 1, linetype = 2) + 
-  theme(legend.position = 'none', plot.margin = unit(c(0,0,0,0),'cm')) +
-  ylab('') + xlab('')
-
-# group mean reproductions
-
-fig_repd_gr = mrep%>% 
-  ggplot(aes(Duration, mRep, color = Volatility, group = Volatility, shape = Volatility)) + 
-  geom_point(alpha = 0.2) + 
-  geom_smooth(method = 'lm', se = FALSE, aes(fill = Volatility)) +
-  theme_classic() + theme(strip.background = element_blank()) +
-  geom_abline(slope = 1, linetype = 2) + 
-  facet_wrap(~group) + theme(legend.position = c(0.1,0.85)) +
-  xlab('Duration (Secs)') + ylab('Reproduction (Secs)')
-
-# plot individual example as inset. 
-
-fig_mrep = ggdraw() + draw_plot(fig_repd_gr) + 
-  draw_plot(fig_asd, x = 0.3, y = 0.13, width  = .2, height = .3) + 
-  draw_plot(fig_td, x = 0.75, y = 0.13, width  = .2, height = .3) 
-  
-fig_mrep
-if(saveFig){
-  ggsave("figures/fig_reproduction.png", fig_mrep, width=7, height=3.5)
-  ggsave("figures/fig_reproduction.pdf", fig_mrep, width=7, height=3.5)
-}
-```
-
-As we can see from the patterns above. The ASD participant produced relative flat errors, while the TD participant showed a strong central tendency effect (shorts being overestimated and longs being underestimated). 
-
-
-### Visulize CTE and sequential dependence
-
-Let's visualize the biases (central tendency and serial dependence) for two groups (ASD vs. TD)
-
-```{r plot_biases}
-pd = position_dodge(width = 0.05)
-
-# plot CTI and SI together
-fig_biases = vslopes%>% 
-  group_by(group, Volatility, Order) %>% 
-  summarise(msi = mean(si), n = n(), se_si = sd(si)/sqrt(n),
-            mci = mean(ci), se_ci = sd(ci)/sqrt(n)) %>%
-  ggplot(aes(msi, mci, color = group, shape = Volatility, 
-              group=interaction(Order, group))) + 
-  geom_hline(yintercept = 0, color = 'gray', linetype = 'dashed') + 
-  geom_vline(xintercept = 0, color = 'gray', linetype = 'dashed') + 
-  geom_point(size = 2) + 
-  geom_line(aes(linetype = Order)) + 
-  geom_errorbar(aes(ymin = mci - se_ci, ymax = mci + se_ci), width = 0.01 ) + 
-  geom_errorbarh(aes(xmin = msi - se_si, xmax = msi + se_si), height = 0.01) + 
-  xlab('Serial Dependence') + ylab('Central Tendency') + 
-  scale_y_continuous(labels = scales::percent) + 
-  scale_x_continuous(labels = scales::percent) + 
-  guides(color = guide_legend(title = 'Group'), 
-         linetype = guide_legend(title = 'Volatility Order'),
-         ) +
-  theme_classic() +
-  theme(legend.position = 'bottom')
-fig_biases
-if (saveFig){
-  ggsave("figures/fig_biases.png", fig_biases, width=5, height=4)
-  ggsave("figures/fig_biases.pdf", fig_biases, width=5, height=4)
-}
-
-
-```
-
-By visual inspection, individuals with ASD exhibited less central tendency relative to their matched TD controls (the red lines below the cyan lines in the above figure), while the local serial dependence was relatively comparable between two groups except in the low volatility condition when that condition started first. Interestingly, the central tendency and serial dependence were similar for both groups when the high-volatility session started first (the solid lines), while they differed when the low-volatility session started first (the dashed lines). 
-
-Given that the main difference was shown in CTE. We further plot the mean CTEs. 
-
-```{r}
-#pd = position_dodge(width = 0.5)
-# separate plots for appendix
-fig_cti = vslopes %>% 
-  group_by(group, Volatility, Order) %>% 
-  summarise(mci = mean(ci), n = n(), se = sd(ci)/sqrt(n)) %>%
-  ggplot(aes(Volatility, mci, shape = Order, color = Order, group = Order)) + 
-  geom_line() + geom_point(size= 2) + 
-  #geom_bar(stat = 'identity', position = pd, width = 0.5) + 
-  facet_wrap(~group)+
-  geom_errorbar(aes(ymin = mci - se, ymax = mci + se), width = 0.2) + 
-  theme_classic() + theme(legend.position = 'bottom', strip.background = element_blank()) +
-  xlab('Volatility') + ylab('CTI') + 
-  scale_y_continuous(labels = scales::percent) + 
-  guides(color = guide_legend(title = 'Order'), fill = guide_legend(title = 'Order'))
-fig_cti
-
-```
-Let's do the sequential dependence as well. 
-
-```{r}
-pd = position_dodge(width = 0.5)
-# separate plots for appendix
-fig_sdi = vslopes %>% 
-  group_by(group, Volatility, Order) %>% 
-  summarise(msi = mean(si), n = n(), se = sd(si)/sqrt(n)) %>%
-  ggplot(aes(Volatility, msi, shape = Order, color = Order, group = Order)) + 
-  geom_line() + geom_point(size = 2) +
-  #geom_bar(stat = 'identity', position = pd, width = 0.5) + 
-  facet_wrap(~group)+
-  geom_errorbar(aes(ymin = msi - se, ymax = msi + se), width = 0.2) + 
-  theme_classic() + theme(legend.position = 'bottom', strip.background = element_blank()) +
-  xlab('Volatility') + ylab('SDI') + 
-  scale_y_continuous(labels = scales::percent) + 
-  guides(color = guide_legend(title = 'Order'), fill = guide_legend(title = 'Order'))
-fig_sdi
-fig3 = plot_grid(fig_cti, fig_sdi, nrow = 1, labels = c("a","b"))
-fig3
-if (saveFig){
-  ggsave('figures/fig3.pdf',fig3, width = 7, height = 3.5)
-  ggsave('figures/fig3.png',fig3, width = 7, height = 3.5)
-}
-
-```
-
-### Statistics
-
-1. Central tendency effect
-
-Average CTIs
-```{r}
-vslopes %>% group_by(group) %>% summarise(mcti = mean(ci))
-vslopes %>% group_by(Volatility) %>% summarise(mcti = mean(ci))
-vslopes %>% group_by(Order) %>% summarise(mcti = mean(ci))
-# calculate mean elevated CTIs between HV First vs. LV First
-vslopes %>% group_by(group, Volatility, Order) %>% summarise(mcti = mean(ci)) %>%
-  pivot_wider(names_from = Order, values_from = mcti) %>% 
-  mutate(dCTI = `HV First` - `LV First`) %>% 
-  group_by(group) %>% summarise(md = mean(dCTI))
-```
-
-
-```{r ANOVAs_cti}
-vslopes = as.data.frame(vslopes) # required by rstatix
-# ---- central tendency index----
-# repeated measures ANOVA on central tendency index
-anova1 = anova_test(data = vslopes, dv = ci, 
-                 wid = sub, 
-                 within = Volatility,
-                 between = c(group, Order))
-anova1
-
-## separate for Volatility order
-anova1a = anova_test(data = vslopes %>% filter(group == 'ASD'), 
-                  dv = ci, 
-                  wid = sub, 
-                  within = Volatility,
-                  between = Order)
-anova1a
-
-anova1b = anova_test(data = vslopes  %>% filter(group == 'TD'), 
-                  dv = ci, 
-                  wid = sub, 
-                  within = Volatility,
-                  between = Order)
-anova1b
-
-```
-
-
-
-2. Bayes factor analysis for pair-wise comparison
-
-The above analysis showed that the main difference came from the central tendency. Here we further get the central tendency bias and Bayes factor analyses:
-```{r cti_bayes}
-
-# --- Bayes t-tests
-bftest = function(df){
-  df = as.data.frame(df)
-  # get the means
-  rdf = df%>% summarise(mci = mean(ci), 
-                        se_ci = sd(ci)/sqrt(n()),
-                        msi = mean(si), 
-                        se_si = sd(si)/sqrt(n()))
-  rdf$ci_bf = ttestBF(df$ci, mu = 0) %>% extractBF() %>% .$bf
-  rdf$si_bf = ttestBF(df$si, mu = 0) %>% extractBF() %>% .$bf
-  return(rdf)
-}
-
-vslopes %>% group_by(group, Volatility, Order) %>% nest() %>%
-  mutate(bf = map(data, bftest)) %>% unnest(bf, .drop = TRUE)
-
-# group comparison for the low-vol-first, high-vol session
-vslopes %>% filter(Volatility == 'High Vola.', Order == 'LV First') %>% as.data.frame() ->v11
-t_test(data = v11, formula = ci ~ group) 
-ttestBF(data = v11, formula = ci ~ group)
-
-vslopes %>% filter(Volatility == 'Low Vola.', Order == 'LV First') %>% as.data.frame() ->v12
-t_test(data = v12, formula = ci ~ group) 
-ttestBF(data = v12, formula = ci ~ group)
-```
-
-
-3. ANOVA analyses for the serial dependence indices:
-
-```{r ANOVAs_sdi}
-# ---- Serial dependence index----
-anova2 = ezANOVA(data = vslopes, dv = si, 
-                 wid = sub, 
-                 within = .(Volatility),
-                 between = .(group, Order))
-anova2$ANOVA
-
-# Bayes factors
-bf = anovaBF(si ~ Volatility + group + Order, data = vslopes, whichRandom = "sub")
-bayesfactor_inclusion(bf) #bayes inclusion values
-
-## separate for session order
-anova2a = ezANOVA(data = vslopes %>% filter(Order == 'LV First'), 
-                  dv = si, 
-                  wid = sub, 
-                  within = .(Volatility),
-                  between = .(group))
-anova2a$ANOVA
-
-anova2b = ezANOVA(data = vslopes %>% filter(Order == 'HV First'), 
-                  dv = si, 
-                  wid = sub, 
-                  within = .(Volatility),
-                  between = .(group))
-anova2b$ANOVA
-
-```
-
-
-
-4. General biases
-
-Additionally we examined the general biases:
-```{r gBias}
-# ---- descriptive of general bias ----
-vslopes %>% group_by(group) %>% summarise(mg = mean(gBias), se = sd(gBias)/sqrt(n())) 
-
-# ANOVA shows no differences
-anova2 = ezANOVA(data = vslopes, dv = gBias, 
-                 wid = sub, 
-                 within = .(Volatility),
-                 between = .(group, Order))
-anova2$ANOVA
-
-bf = anovaBF(gBias ~  group + Volatility + Order, 
-             data = as.data.frame(vslopes), whichRandom = "sub")
-bayesfactor_inclusion(bf) #bayes inclusion values
-
-
-```
-We then visualize the general biases
-```{r plotgBias}
-# --- general bias
-fig_bias = vslopes %>% group_by(group, Volatility, Order) %>%
-  summarise(mbias = mean(gBias), n = n(), se = sd(gBias)/sqrt(n)) %>%
-  ggplot(aes(Volatility, mbias, color = Order,linetype = group, group = interaction(Order, group), shape = group)) + 
-  geom_point(size = 3, position = pd) + 
-  geom_line(position = pd) +
-  geom_errorbar(aes(ymin = mbias - se, ymax = mbias + se), width = 0.2, position = pd) + 
-  theme_classic()  + theme(legend.position = 'bottom') + xlab('Volatility') + 
-  ylab('Mean overestimation (ms)') 
-fig_bias
-```
-
-There was no difference in two groups in general biases, although both groups were positive overestimated. 
-
-Next we examined the reproduced variability:
-```{r rep_var}
-# ---- Reproduction variability -----
-msds_r <- mrep  %>% 
-  filter(n>5) %>% 
-  group_by(group, Order, Volatility,  sub) %>%
-  summarise(msd = mean(sdr), n=n(), msd_se = sd(sdr)/sqrt(n))
-  
-
-sd_ANOVA <- ezANOVA(msds_r, dv=msd, wid=sub, between=.(group,Order), within=Volatility)
-sd_ANOVA$ANOVA
-
-mmsds_r <- msds_r %>% summarize(mmsd=mean(msd*1000), n = n(), se = sd(msd*1000)/sqrt(n))
-
-pd = position_dodge(width = 0.5)
-fig_sd <- ggplot(mmsds_r, aes(Volatility, mmsd, shape = Order, color = Order, group = Order)) + 
-  geom_line() + geom_point() + 
-  #geom_bar(stat = 'identity', position = pd, width = 0.5) + 
-  geom_errorbar(aes(ymin = mmsd - se, ymax = mmsd + se), width = 0.3) +
-  facet_wrap(~group) +
-  ylab('Mean Standard Deviation (ms)') + xlab('Volatility') + theme_classic()  
-#  coord_cartesian(ylim = c(140, 200)) 
-fig_sd
-
-if(saveFig){
-  ggsave('figures/fig_sd.png', fig_sd, width=5, height=4)
-  ggsave('figures/fig_sd.pdf', fig_sd, width=5, height=4)
-}
-
-
-
-```
-
-## Correlation analysis
-
-Next we import individual participant ratings and do correlation analyses. 
-
-```{r parinfo}
-pinfo = read.csv('data/parinfo.csv')
-
-# join with ctis, sdis
-res = left_join(vslopes, pinfo, by = c('group','sequence'))
-res$group = as.factor(res$group)
-
-# scatter plot to see any relations
-fig_corr = ggduo(res, c('AQ','EQ','BDI'), c('ci','si'), mapping = aes(color = group, shape = Order),
-      types = list(continuous = 'smooth_lm', se = FALSE), 
-      showStrips = FALSE, legend = 3,
-      columnLabelsY = c('CTI','SDI')) + 
-  theme_classic() + theme(legend.position = 'bottom', strip.background = element_blank()) 
-if(saveFig){
-  ggsave('figures/fig_corr.png', fig_corr, width=5, height=4)
-  ggsave('figures/fig_corr.pdf', fig_corr, width=5, height=4)
-}
-
-fig_corr
-```
- Get linear regression out
- 
-```{r}
-ci_AQ <- function(df){
-  lm(ci ~ AQ, data = df)
-}
-ci_EQ <- function(df){
-  lm(ci ~ EQ, data = df)
-}
-ci_BDI <- function(df){
-  lm(ci ~ BDI, data = df)
-}
-
-si_AQ <- function(df){
-  lm(si ~ AQ, data = df)
-}
-si_EQ <- function(df){
-  lm(si ~ EQ, data = df)
-}
-si_BDI <- function(df){
-  lm(si ~ BDI, data = df)
-}
-
-# regression
-reg_res <- res %>% group_by(Volatility, group, Order) %>%
-  nest()  %>%  # nested data
-  mutate(ci_AQ = map(data, ci_AQ), ci_EQ = map(data, ci_EQ),
-         ci_BDI = map(data, ci_BDI), 
-         si_AQ = map(data, si_AQ), si_EQ = map(data, si_EQ),
-         si_BDI = map(data, si_BDI)) %>%
-  mutate(mci_AQ = map(ci_AQ, broom::tidy), 
-         mci_EQ = map(ci_EQ, broom::tidy),
-         mci_BDI = map(ci_BDI, broom::tidy),
-         msi_AQ = map(si_AQ, broom::tidy),
-         msi_EQ = map(si_EQ, broom::tidy),
-         msi_BDI = map(si_BDI, broom::tidy)  ) %>%
-  unnest(cols = c(mci_AQ, mci_EQ, mci_BDI, msi_AQ, msi_EQ, msi_BDI), names_repair = 'unique' , .drop = TRUE) %>%
-  select(-ci_AQ, -ci_BDI, -ci_EQ, -si_AQ, -si_EQ, -si_BDI, -data, 
-         -starts_with('st')) %>% 
-  filter(term == 'AQ') # remove intercept
-
-```
-
-Given there is no significant of slopes (after correction), but some difference in intercepts, we do general linear regression, without separating groups. 
-
-```{r}
-reg_res2 <- res %>% ungroup() %>% group_by(Order, Volatility) %>%
-  nest()  %>%  # nested data
-  mutate(ci_AQ = map(data, ci_AQ), ci_EQ = map(data, ci_EQ),
-         ci_BDI = map(data, ci_BDI), 
-         si_AQ = map(data, si_AQ), si_EQ = map(data, si_EQ),
-         si_BDI = map(data, si_BDI)) %>%
-  mutate(mci_AQ = map(ci_AQ, broom::tidy), 
-         mci_EQ = map(ci_EQ, broom::tidy),
-         mci_BDI = map(ci_BDI, broom::tidy),
-         msi_AQ = map(si_AQ, broom::tidy),
-         msi_EQ = map(si_EQ, broom::tidy),
-         msi_BDI = map(si_BDI, broom::tidy)  ) %>%
-  unnest(cols = c(mci_AQ, mci_EQ, mci_BDI, msi_AQ, msi_EQ, msi_BDI), names_repair = 'unique' , .drop = TRUE) %>%
-  select(-ci_AQ, -ci_BDI, -ci_EQ, -si_AQ, -si_EQ, -si_BDI, -data, 
-         -starts_with('st')) %>% 
-  filter(term == 'AQ') # remove intercept
-```
-Again, there is no significant of slopes. 
-
-
-

File diff suppressed because it is too large
+ 3403 - 0
analysis-notebook.ipynb


File diff suppressed because it is too large
+ 0 - 2588
analysis-notebook.nb.html


+ 117 - 0
data/arx_v.csv

@@ -0,0 +1,117 @@
+sub,Volatility,group,Intercept,CTI,preErr,p_Intercept,p_CTI,p_preErr,r2,sequence,aic
+A31,High Vola.,ASD,-0.1636260720515039,0.4485224319912138,0.02267592408234776,5.643183347748399e-16,6.771624821062973e-26,0.6684554604295787,0.3844330385828979,31.0,17.776498382325315
+A31,Low Vola.,ASD,-0.10218809237514949,0.22326622574396415,0.522758690842801,1.3108914741665312e-07,3.0482280141717553e-07,3.196388925400576e-17,0.5910267907291533,31.0,-75.86969096872241
+A33,High Vola.,ASD,-0.05461602512957113,0.24397159621097486,0.009412266964022028,3.5569954227961165e-05,2.8372755154495363e-12,0.8731748871635254,0.18931649097910952,33.0,-107.55634331515569
+A33,Low Vola.,ASD,-0.03255699134999322,0.06755747060938369,-0.002898183522044155,0.002004785052565156,0.014240003477907364,0.9631010027182318,0.025517836661714588,33.0,-207.87865998006976
+A34,High Vola.,ASD,-0.02578538594133569,0.5146889415137618,-0.13064464268654952,0.004590109364508344,7.936835243503047e-51,0.001516159000523315,0.6350146585860621,34.0,-264.8038593367695
+A34,Low Vola.,ASD,-0.010153890455653635,0.14845994955957106,0.24643623448798252,0.34958963933195486,9.269358845916346e-06,7.720025573986404e-05,0.18613376937898696,34.0,-175.70395953235914
+A36,High Vola.,ASD,0.014731446448256563,0.1435456635804631,0.08775944302428886,0.5394665758854196,0.006476222322553425,0.19102806114674817,0.04428809582188431,36.0,171.71912238951
+A36,Low Vola.,ASD,0.041862423283285155,0.23651102076482447,0.21389504762302303,0.08168914861061881,2.185953779060046e-05,0.0013372733245813062,0.17314302731806586,36.0,167.86686610512993
+A37,High Vola.,ASD,0.09162193051190788,0.2834625244771001,0.00442976069701978,4.393486334425022e-09,4.2069523423343306e-13,0.9416218778419272,0.20824776992431326,37.0,-54.58527263259532
+A37,Low Vola.,ASD,0.06370068676966169,0.12606579900653403,0.18982397529832182,1.5226653254374147e-06,0.00011549456645900031,0.0032828978952987894,0.12547259209593753,37.0,-127.04657691180506
+C33,High Vola.,TD,0.018955005406609736,0.2022236357009768,-0.051431218015480486,0.027435932329382903,1.1820329014007027e-16,0.36956857093127526,0.25760599585544774,33.0,-292.23100349193
+C33,Low Vola.,TD,-0.01536659809324257,0.08188278055455188,0.09783079734044839,0.05073982597180892,0.00015414322623639933,0.12890316485502235,0.08115210273393991,33.0,-333.29249128659103
+C34,High Vola.,TD,0.07398806428643265,0.4325160876472684,0.007729881101008071,5.85322163161728e-07,4.390304652368354e-22,0.8837029701942037,0.33013771316627405,34.0,-57.091354329818216
+C34,Low Vola.,TD,0.13247578485527017,0.04861377064700744,0.16644201563446392,1.5136493338074298e-15,0.16684849231488716,0.008796892446623714,0.03995133666753614,34.0,-122.35081100561996
+C36,High Vola.,TD,-0.058175435452518694,0.33415807339852405,-0.13654445612204624,4.1070570280239215e-06,3.953428960175924e-28,0.007870734060773169,0.4097797204159317,36.0,-125.16496944179556
+C36,Low Vola.,TD,-0.026605000229549633,0.17004147699675906,0.20948021333875252,0.008393673247956228,1.1979341030810306e-10,0.0010537377256638928,0.32475114565313135,36.0,-221.4173536892685
+C37,High Vola.,TD,0.11774014092656433,0.17689445089121614,0.2231123500348675,5.307883745650459e-09,5.64689730794965e-05,0.0003260589853711634,0.11192196203324623,37.0,34.43670352762621
+C37,Low Vola.,TD,0.12347785686076401,-0.006048437493706503,0.3122562010013119,9.389217444350507e-12,0.8541202604852834,8.088261702743881e-07,0.09899102500328905,37.0,-98.0076337726959
+ara27,High Vola.,ASD,0.07219142662654182,0.11779895809540702,-0.006780246811204843,7.3268673617742895e-06,0.0030104883003992324,0.91564669222547,0.03659882101510048,27.0,-17.39988909689663
+ara27,Low Vola.,ASD,0.08543794975761719,-0.04679962333478706,0.10092203539634838,6.762791259033084e-08,0.20495589987264923,0.1132380491630388,0.018736028882605504,27.0,-48.730448121853385
+ara29,High Vola.,ASD,-0.02441612435884697,0.3291267680057361,-0.005594467250589964,0.06824627985719092,4.828084553268933e-21,0.9190289535131004,0.317031070761411,29.0,-78.01508754424037
+ara29,Low Vola.,ASD,0.06095867715216052,-0.0706292912482655,0.12488577699171932,3.8062741468439536e-08,0.004024704707987095,0.05481080923202136,0.0586963089888376,29.0,-212.26813987692458
+arc17,High Vola.,ASD,0.06080713259323861,-0.0073531506678730235,-0.07758704770360869,8.382565462209338e-08,0.8697758020034771,0.2234636279877569,0.006314150820637687,17.0,-200.98601995858093
+arc17,Low Vola.,ASD,0.15818837125878676,-0.22250559141698664,0.004673430975434545,3.015298463884902e-19,7.69575180011722e-05,0.9417086717542758,0.06983319093363383,17.0,-116.67482947094624
+arc21,High Vola.,ASD,0.06580218035627212,0.20768285790698507,0.10945699959732277,1.0397959688574304e-09,2.6736318085462345e-07,0.0800305459164769,0.1195811353622761,21.0,-240.52520541759503
+arc21,Low Vola.,ASD,0.04076613603584671,0.10639915149942233,0.2776401531296837,7.007908881747416e-05,0.00882847387212755,1.4297428273440233e-05,0.1236210602136224,21.0,-245.40776131713886
+ard07,High Vola.,ASD,0.07751478956101898,0.4195024964492992,-0.05975104047594887,2.830541222416066e-07,7.224824405463371e-12,0.32074729831599974,0.18020099161816294,7.0,-54.06010835811429
+ard07,Low Vola.,ASD,0.09170494905110693,0.015824672302819302,0.10624236021920108,3.937648811887781e-10,0.7600325203115247,0.10035899414806003,0.011901145670669577,7.0,-105.16942065443271
+are28,High Vola.,ASD,-0.08387337605544508,0.30919417215899303,0.0033921960520941104,2.012880395836989e-09,6.286854975863321e-19,0.9503927534937574,0.2863722862100543,28.0,-103.99216624271247
+are28,Low Vola.,ASD,-0.035022867487362865,0.21446821888964546,0.20957101131967074,0.0003479646606726549,5.313055281523938e-12,0.0015285477103873304,0.3867132039439555,28.0,-247.23069600635557
+arek04,High Vola.,ASD,0.0740932609431003,0.24897655967168933,0.02526861074520356,3.037702527405393e-09,5.596465050058993e-09,0.690636931959371,0.13381817106739102,4.0,-165.04056346210297
+arek04,Low Vola.,ASD,0.09251130841899258,0.039974515529447495,0.12007814353950257,1.2327261124818358e-15,0.19913412212229947,0.06713331185354762,0.022740837431732497,4.0,-299.07034752614027
+arj08,High Vola.,ASD,0.01983193757878396,0.06794287195997059,-0.09254537452366553,4.1330114373794566e-05,0.0007822944798702231,0.13796787152991022,0.05741987772623158,8.0,-583.1372699921149
+arj08,Low Vola.,ASD,0.003427310745697458,0.0503432658482941,0.19881259856660233,0.3983228475689108,0.005386645978182385,0.0014922846529295609,0.08907161999127156,8.0,-645.4710945124409
+arj19,High Vola.,ASD,0.1541243299215094,0.37334665574409853,-0.14076436915291546,2.6839079704519386e-17,2.29369989949282e-09,0.0178897857505793,0.1605732985318693,19.0,-10.088586871822656
+arj19,Low Vola.,ASD,0.12051372067260671,0.036742177461673936,0.1040206784221791,3.628545175335289e-14,0.4466824346647479,0.09608734952533722,0.014916888021068386,19.0,-117.86096735504185
+arjs01,High Vola.,ASD,0.03644628224469795,0.2595079928904515,-0.11096226077357746,0.003803240817189363,9.142231746569929e-06,0.08349803955485814,0.087738606355382,1.0,-109.96836135304017
+arjs01,Low Vola.,ASD,-0.008114412576098603,0.042735606429927984,0.01994099359641337,0.5039116087523507,0.4477017158859681,0.7578900430148613,0.0029432747391193725,1.0,-119.50686069181342
+ark09,High Vola.,ASD,0.055264423272441854,0.4229733715674244,-0.03584644202212572,3.4593731057487924e-11,2.9014843573363026e-28,0.46172518431649334,0.4019558198156802,9.0,-350.5933678560723
+ark09,Low Vola.,ASD,-0.008707221522620824,0.2530442234639373,0.09098569754404487,0.20430713258240565,1.0930162553359437e-11,0.1575025388638127,0.2633847436017923,9.0,-395.2427774959149
+ark11,High Vola.,ASD,0.044774083944122856,0.0013971531741124778,-0.010172502151479305,0.00023593418965240438,0.9760520896736262,0.8809320508947309,9.821589302572153e-05,11.0,-138.88757022589323
+ark11,Low Vola.,ASD,0.01962200329238898,0.0055351110800298114,-0.011831865627506242,0.1683584465104709,0.9214239512839865,0.8611012158440396,0.00016852329439898117,11.0,-47.059100994874655
+arl10,High Vola.,ASD,0.05811771771511162,0.476622964505967,0.12306429069240349,9.053551631823713e-05,8.709426953902144e-16,0.02893312683336422,0.2671863153586642,10.0,-47.13647570935717
+arl10,Low Vola.,ASD,0.03859613644189701,0.20209549079555278,0.04979091604795677,0.0010057906104429537,1.8848293894674584e-05,0.44747544180417886,0.09271714067802606,10.0,-154.02652675503822
+arm20,High Vola.,ASD,-0.028404248460278052,0.43798325768794677,-0.0991313122248752,0.02037444794165968,3.2407832612999395e-23,0.05957028947075933,0.35082713667006404,20.0,-120.23687824393443
+arm20,Low Vola.,ASD,-0.01960049600150255,0.11898560738611837,0.14075357575617664,0.0630699128617274,0.0006752911791122232,0.035475557367586424,0.08230919920359336,20.0,-196.81225888633583
+arm25,High Vola.,ASD,-0.02208367459059903,0.5342022992071701,-0.019195910202635547,0.0568982299327992,2.8666821318221e-24,0.7155446995210395,0.3564392183114642,25.0,-145.26465354153578
+arm25,Low Vola.,ASD,0.06077703614352044,-0.011888161970804135,0.1315520140105213,1.1339316912593784e-06,0.800208843070437,0.0416440349619487,0.017888536926087606,25.0,-152.44606195174106
+arm26,High Vola.,ASD,0.036904645637965,0.2149697990741385,0.055293965326029794,0.00018888952672712906,1.6672310590045359e-06,0.34649646256946787,0.09580837236189432,26.0,-240.16930481882292
+arm26,Low Vola.,ASD,0.05654619123240877,0.10543143176740338,0.13092890893954628,1.4218725905202287e-10,0.0024413752593429616,0.043005720050990216,0.062264432153819715,26.0,-359.60555582701227
+arnnew15,High Vola.,ASD,0.12093177510010432,0.13339809516475856,0.004041876303171904,1.9656295224343266e-11,0.02027778496914787,0.9494692317144813,0.022714481370090356,15.0,-12.200109412610402
+arnnew15,Low Vola.,ASD,0.09624365625192016,0.23897032993936124,-0.003241094668807832,7.763776142271405e-09,6.71787358151324e-05,0.9584801699697008,0.06784013028672142,15.0,-10.34950729330916
+arp23,High Vola.,ASD,0.17862284095665742,0.040575663576851696,0.039655392251379165,3.7510793222955235e-20,0.3975602047071737,0.5440559670301844,0.0046408158073278916,23.0,-86.76554258789116
+arp23,Low Vola.,ASD,0.14469705805853084,-0.17195408199896767,0.12569771995956833,1.0768541683511537e-15,0.0005158361050793948,0.053144155827812,0.08121650691211968,23.0,-86.79989930799974
+ars06,High Vola.,ASD,0.010155791093193835,0.3123480671258252,-0.06986376330452221,0.20790802267041728,4.988738656578609e-13,0.21648200241421486,0.20519381701857609,6.0,-315.41024041949595
+ars06,Low Vola.,ASD,0.032877920959560436,0.11445193908483764,-0.09612114657045501,0.0004426277926831698,0.014909616501907346,0.13785390444178547,0.030153703303823276,6.0,-261.03074014925875
+ars14,High Vola.,ASD,-0.14065216990865648,0.34025157980955517,-0.07826346084544367,8.438571143918126e-14,2.5508944607471274e-09,0.20209355049286953,0.14194930953976326,14.0,9.12618572727223
+ars14,Low Vola.,ASD,-0.11137150465122082,0.3798401888621049,0.013318646039922496,3.414059004529916e-14,5.709227745181217e-14,0.8369612625340657,0.271181250524547,14.0,-129.4905833351881
+arsn05,High Vola.,ASD,0.09726790223443815,0.30613110839348756,0.016472355977979296,2.4789291719980715e-15,5.266003700127983e-17,0.7748957174541329,0.25786401188685104,5.0,-211.84785236925052
+arsn05,Low Vola.,ASD,0.11622146697040645,0.02252888097069324,0.08845734828304012,1.2087531581081526e-16,0.5304230769399356,0.1547397194965576,0.010554125708249984,5.0,-180.56212216936171
+art12,High Vola.,ASD,0.1237235879228884,0.06585523284691705,0.006221680326570125,7.091851373067496e-16,0.13925220582011988,0.923796212631494,0.00947616373604443,12.0,-137.30199778548712
+art12,Low Vola.,ASD,0.11095702689600606,-0.024211496690589633,0.1817858829992351,2.0867927705594902e-14,0.5486447050689041,0.004329539644236443,0.03583452268966236,12.0,-181.9067476725121
+art16,High Vola.,ASD,-0.007724327598806427,0.21546073039000146,-0.06197537756508375,0.4065041182220308,1.769904423163741e-08,0.31633036663896,0.12944943273746568,16.0,-247.3504254183029
+art16,Low Vola.,ASD,0.03337339294745937,0.14309754285087978,0.09188882298000003,0.0006070429430725827,0.0002581867611896516,0.20592250804065776,0.07085215055729932,16.0,-243.75778454897244
+arv22,High Vola.,ASD,0.07735341229989676,0.25690751401318235,0.03697214375523539,2.599392379802637e-11,1.355675898234143e-09,0.5449998186954216,0.14410952571422275,22.0,-220.09345304629898
+arv22,Low Vola.,ASD,0.07420317157825182,-0.011864654313343423,-0.02390693159342061,7.788514660771696e-08,0.8175822160209358,0.7133760962425635,0.0007946879659508355,22.0,-104.52613249580696
+c31,High Vola.,TD,0.019224642109701377,0.12596328574423768,0.13500356707522565,0.04404896794815055,1.1344098145255786e-08,0.022955122337820384,0.15000516055311974,31.0,-244.0678368105045
+c31,Low Vola.,TD,0.04669055321462873,-0.04313702423808272,0.10651639776542714,1.9590293839018168e-05,0.06700422662997194,0.10248182909768748,0.029754246869931444,31.0,-207.48221011420338
+cra08,High Vola.,TD,0.04708933264646638,0.29290840809452734,-0.026088194085325964,2.7786413804939676e-05,1.991945390121498e-09,0.667738417106963,0.14287715094581643,8.0,-179.82887099495713
+cra08,Low Vola.,TD,0.026126642768255146,0.15380489556967405,-0.037254359560420815,0.001181811631072114,1.7278278440561606e-05,0.5699997053199815,0.07662430379268059,8.0,-330.4618804457614
+cra20,High Vola.,TD,0.035039399717327044,0.5334832184838312,0.0119976968169666,0.036884423496039175,1.8580800905501862e-19,0.8294983940862918,0.2955090600732744,20.0,28.36520563043632
+cra20,Low Vola.,TD,0.056753359156716934,-0.17536501242696384,0.2267050978547558,0.01688628421612869,0.022129723495821364,0.0004440947132992549,0.08397662687144758,20.0,173.89458027745508
+crc10,High Vola.,TD,0.06313228926882654,0.32239040433185895,0.33577702143147115,9.307115260222668e-08,1.508803647481331e-14,2.455594941791924e-09,0.30194971617390454,10.0,-205.72418264877564
+crc10,Low Vola.,TD,0.14651686443151343,0.08592022390507009,0.137964252152444,3.2734377153776625e-18,0.056854135184408,0.033006576272671,0.0373868094281824,10.0,-148.43616331425142
+crd19,High Vola.,TD,0.039856360974066286,0.2568680048443859,0.029240237367659967,4.385785021768721e-05,1.2372631941307366e-11,0.6189968466447845,0.17911729739265492,19.0,-248.86608834768754
+crd19,Low Vola.,TD,0.044804896036745784,0.026846028630323718,0.010715037000003515,7.769795733292314e-07,0.4166126210603387,0.8679403810153994,0.0029592737061576724,19.0,-298.94448544021134
+cre04,High Vola.,TD,0.08396629549720261,0.28840822932353094,0.040052697487123076,1.415886088749004e-06,2.5965054363224916e-06,0.5254568946685931,0.09137206896914607,4.0,12.35867853684158
+cre04,Low Vola.,TD,0.08857543840625172,0.1447890844560858,0.14230187612484982,9.265494684828708e-10,0.002119560662705553,0.027650784555972554,0.07121924414427505,4.0,-112.33152485366094
+cre05,High Vola.,TD,-0.018853243437023513,0.42888724066958583,0.09613051951747638,0.13364440659907095,1.713597931068841e-20,0.07941817372219705,0.3118942575587298,5.0,-105.4716212082912
+cre05,Low Vola.,TD,0.043033440410328895,0.005562962289152474,0.15847237485877974,0.00445348874543658,0.910010892391013,0.023040610187974903,0.02182075373196546,5.0,-29.521064494519635
+cre11,High Vola.,TD,-0.028303006195997366,0.4641110334198696,0.09566766171693439,0.0026434660101445876,5.269687461820348e-29,0.059854058965669955,0.42991814281946594,11.0,-250.74145517242948
+cre11,Low Vola.,TD,-0.06924229007552363,0.18180195847453703,0.3300515879238678,9.18876431239962e-11,6.370151954842244e-07,1.7376249134059954e-07,0.2985831188110807,11.0,-316.1381523668954
+crf27,High Vola.,TD,-0.03072573364949042,0.22464669467170556,-0.0502032034657388,0.0015828606306057206,1.4363268890062065e-16,0.3678535308578179,0.2507348147639551,27.0,-235.2513812049545
+crf27,Low Vola.,TD,-0.0331945494170303,0.12411710185849889,0.07431555625682541,0.0009293331377832643,4.992143314773659e-06,0.24303963805532613,0.11279541353977218,27.0,-230.20688752731564
+crj12,High Vola.,TD,0.14016340062585697,0.4180878866628422,-0.012048706493201122,2.1971515723858576e-20,2.381422702985692e-18,0.8276525949572324,0.2760753123314088,12.0,-141.0228978339465
+crj12,Low Vola.,TD,0.15162338438778467,0.04865469421048308,0.0033873708292149265,1.745325186459415e-21,0.2389834473560919,0.9562393597807319,0.005945976886958304,12.0,-172.2129970655804
+crj22,High Vola.,TD,0.06550853025056008,0.21445538434279332,0.03270513747579508,1.573077096250259e-07,1.2413751394828015e-05,0.6065995262346131,0.07912325232293504,22.0,-146.2609880017278
+crj22,Low Vola.,TD,0.042885398068122,0.16661930896640836,0.08562948351465284,9.517520612025455e-07,3.627738855722999e-06,0.17816121012134836,0.11983365115222744,22.0,-315.8236695155276
+crj23,High Vola.,TD,0.04026320337273456,0.33267238460660986,-0.0010515760976161446,6.131481736062675e-05,3.044190049060796e-18,0.9848642866793726,0.2744423966687869,23.0,-228.2237459224081
+crj23,Low Vola.,TD,0.012562074129221914,0.15904058217539527,0.3170530667466137,0.12398897492204342,1.523088599660967e-06,2.1184835898049398e-07,0.2710843520061489,23.0,-312.3492182063899
+crk21,High Vola.,TD,0.05072025108429428,0.02371549933168706,-0.011024791056087696,0.0007195217138918402,0.6959414078407202,0.8633024508154125,0.0007709038386601863,21.0,-32.63873469774131
+crk21,Low Vola.,TD,0.002929483030805588,0.15200786802813762,0.16087925271426615,0.7611473404838695,0.0003976340367913146,0.01081119529036618,0.10146027756627274,21.0,-229.48392139950687
+crl25,High Vola.,TD,0.011768685836116918,0.5896055198662754,-0.11454086538147007,0.3397818363845071,1.7643456098563444e-25,0.027363794706993787,0.3796401757442759,25.0,-112.9300615130793
+crl25,Low Vola.,TD,0.043413691625760864,0.07505843401682599,0.05223616976902557,0.0006355371094952851,0.14024786141528656,0.43232793177131223,0.013380461228984064,25.0,-117.52547956220991
+crl26,High Vola.,TD,0.08140313453488786,0.17034619502253281,0.15508070837019217,2.659649261125435e-06,7.83085319189209e-06,0.012132758649910468,0.11336230241019818,26.0,4.4303625483461815
+crl26,Low Vola.,TD,0.05845005839991678,0.03348247437845755,0.19519160857532072,6.315545163396346e-06,0.22615677329388567,0.001036003100549344,0.051407387869960575,26.0,-132.60182426358915
+crm07,High Vola.,TD,0.0447874581717078,0.30542365124139464,0.01789894956871694,2.5088401236465036e-07,3.993800330979792e-17,0.7414921356371146,0.2586722551741315,7.0,-310.6025613648965
+crm07,Low Vola.,TD,0.0412568690841571,0.17248339464664109,0.10616265717103995,7.358311638281642e-09,2.0152389855056138e-08,0.084609034243984,0.19207271825841388,7.0,-422.5419279120297
+crm16,High Vola.,TD,-0.08255191885067265,0.6222072885622131,0.029119526978998632,9.210850622651171e-11,1.542701367793074e-30,0.5475302394737167,0.4289299109324969,16.0,-146.273413123968
+crm16,Low Vola.,TD,-0.02676529980875586,-0.015969392935027898,0.32327697080443335,0.026775239184777404,0.7399545070328851,2.438671236224273e-07,0.10811002054141883,16.0,-135.2294015743277
+crmn29,High Vola.,TD,-0.04490211955417679,0.28170591427319114,-0.13789647019876958,2.565865363906311e-06,2.1920877189763752e-33,0.005401824332291873,0.47412300280095954,29.0,-257.57314164088683
+crmn29,Low Vola.,TD,0.01782925869146359,0.10286566300380179,0.004025731504420042,0.028478314518966416,5.063372573056754e-07,0.9503982240325818,0.10904578867145087,29.0,-317.77118203696364
+crn09,High Vola.,TD,-0.06199659182258668,0.5405434286025681,-0.026370926077060368,1.6139643428116947e-07,9.92408938657009e-23,0.6257049077430372,0.335014575683914,9.0,-167.32390381475665
+crn09,Low Vola.,TD,-0.030687703291489968,0.1447853100666647,0.2628311902142174,0.00033219809366437104,0.0001384728652237322,4.210068840089356e-05,0.15257883852856313,9.0,-313.54921302147454
+crn15,High Vola.,TD,0.029083663250644678,0.44730082463837934,0.00923572577905047,0.005215256042148905,1.0527730781463578e-24,0.8615305012039745,0.36772958516781284,15.0,-203.03489073256708
+crn15,Low Vola.,TD,0.03598088746992113,0.0991058946504293,0.1356915056802264,0.0007726813876239914,0.012854940469600314,0.03804639059469429,0.05360722313102828,15.0,-203.3171264813962
+crp14,High Vola.,TD,0.06484234741831628,0.6301266124341555,0.007344594653196937,7.251223645343384e-07,9.324593706210686e-35,0.8722860492329836,0.4752918264607543,14.0,-110.78931619934718
+crp14,Low Vola.,TD,-0.02973499501235844,0.18010199855108863,0.14825132602864458,0.00756142424119892,8.01727765221628e-06,0.018379197450837676,0.13146387776697654,14.0,-169.22476466866755
+crs06,High Vola.,TD,0.011880156074371255,0.4416987372995401,0.10845796505415228,0.1576079942395089,2.0776298183247516e-21,0.05318517346991562,0.322913235809422,6.0,-297.0452045856241
+crs06,Low Vola.,TD,0.009165480704601657,0.1622511258401341,0.4535950735219698,0.1651815104233781,1.7486593444340247e-05,5.5330093127446694e-14,0.36844343631303833,6.0,-413.58825978812604
+crs28,High Vola.,TD,0.006502165040361435,0.3577955604595286,-0.050109002723533524,0.6273936264371149,8.723447781741356e-22,0.3472242042015683,0.32222128085141033,28.0,-71.62397035590624
+crs28,Low Vola.,TD,0.08374907752863123,0.01813953808918116,0.07353017011070515,7.0348908946121125e-09,0.5640369517661132,0.27278860026150614,0.006644901656302493,28.0,-101.27278713117556
+crt17,High Vola.,TD,0.014987381470636635,0.3265492244419964,-0.035867686555865384,0.06620799102628958,1.811572259485956e-17,0.5175865066736822,0.26472137898492853,17.0,-314.3717106705683
+crt17,Low Vola.,TD,0.031782730012484384,-0.032064809563179315,0.07605193193201977,6.448164605581037e-05,0.32860633106152204,0.24409888267616214,0.010266596486961821,17.0,-348.70005127164313
+crv01,High Vola.,TD,0.009153200353798317,0.30174263673895296,0.2155706377682682,0.30562905180255406,4.797029923280041e-12,0.00023862461378270099,0.22504807069612187,1.0,-267.5420204045804
+crv01,Low Vola.,TD,0.008343401227858737,0.07613931721183068,0.2077018347713166,0.364143398319121,0.07543154676665159,0.0010553136355181487,0.061747894980397566,1.0,-254.0041404604744

+ 10 - 6
datacite.yml

@@ -11,19 +11,23 @@ authors:
     lastname: "Shi"
     affiliation: "Department of Psychology, Ludwig-Maximilians-Universität München, Munich, Germany"
     id: "ORCID:0000-0003-2388-6695"
-  -
-    firstname: "Laura A."
-    lastname: "Theisinger"
-    affiliation: "Department of Psychiatry and Psychotherapy, Ludwig-Maximilians-Universität München, Munich, Germany"
   -
     firstname: "Fredrik"
     lastname: "Allenmark"
     affiliation: "Department of Psychology, Ludwig-Maximilians-Universität München, Munich, Germany"
     id: "ORCID:0000-0002-3127-4851"
+  -
+    firstname: "Laura A."
+    lastname: "Theisinger"
+    affiliation: "Department of Psychiatry and Psychotherapy, Ludwig-Maximilians-Universität München, Munich, Germany"
   -
     firstname: "Rasmus L."
     lastname: "Pistorius"
     affiliation: "Department of Psychiatry and Psychotherapy, Ludwig-Maximilians-Universität München, Munich, Germany"
+  -
+    firstname: "Stefan"
+    lastname: "Glasauer"
+    affiliation: "Computational Neuroscience, Brandenburg University of Technology Cottbus-Senftenberg, Cottbus, Germany"
   -
     firstname: "Hermann J."
     lastname: "Müller"
@@ -35,11 +39,11 @@ authors:
     
 
 # A title to describe the published resource.
-title: "Dataset of Predictive coding in ASD: reduced adaptability of prior to environmental changes"
+title: "Duration Reproduction Dataset in high/low Volatility for ASD and TD individuals"
 
 # Additional information about the resource, e.g., a brief abstract.
 description: |
-  Data and codes for the study of predicitiv coding in ASD
+  Data and codes for the study of Duration reproduction in high/low volatility for ASD and TD individuals.
 
 # Lit of keywords the resource should be associated with.
 # Give as many keywords as possible, to make the resource findable.

BIN
figures/acf_rep_err.pdf


BIN
figures/acf_rep_err.png


BIN
figures/ar_dw.pdf


BIN
figures/ar_dw.png


BIN
figures/cti_boxplot.png


BIN
figures/fig3.pdf


BIN
figures/fig3.png


BIN
figures/fig_corr.pdf


BIN
figures/fig_corr.png


BIN
figures/fig_o.pdf


BIN
figures/fig_o.png


BIN
figures/fig_outlier.pdf


BIN
figures/fig_outlier.png


BIN
figures/fig_reproduction.pdf


BIN
figures/fig_reproduction.png


BIN
figures/fig_sd.png


BIN
figures/fig_sdep31.pdf


BIN
figures/fig_sdep31.png


BIN
figures/fig_sequence.png


BIN
figures/hist_fig.pdf


BIN
figures/hist_fig.png


BIN
figures/outliers.png


BIN
figures/rep_err_vs_Duration.png


BIN
figures/rep_pred_err.pdf


BIN
figures/rep_pred_err.png


BIN
figures/sequential_effect.pdf


BIN
figures/sequential_effect.png